From michael.werner at dlr.de Wed Aug 1 03:11:33 2018 From: michael.werner at dlr.de (Michael Werner) Date: Wed, 1 Aug 2018 10:11:33 +0200 Subject: [petsc-users] slepc4py - Using shell matrix and explicit preconditioning matrix to solve EPS Message-ID: Hello, I'm trying to find the smallest eigenvalues of a linear system created by CFD simulations. To reduce memory requirements, I want to use a shell matrix (A_Shell) to provide the matrix-vector product, and a lower-order explicit matrix (P) as preconditioner. As I'm solving a generalized problem, I'm also passing a second explicit matrix (B) to the EPS. However, I don't see a way to provide the explicit preconditioning matrix to the EPS. I'm using the following options: -st_type sinvert -st_pc_type lu -st_matmode shell -eps_target 0.01 -eps_target_real My Python code looks like this: E = SLEPc.EPS().create(comm=PETSc.COMM_WORLD) E.setOperators(A_Shell, B) E.setProblemType(SLEPc.EPS.ProblemType.GNHEP) st = E.getST() ksp = st.getKSP() pc = ksp.getPC() pc.setOperators(A_Shell, P) E.setFromOptions() E.solve() If I run this, I get the following error: > Error: error code 92 > [2] EPSSolve() line 135 in > /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/eps/interface/epssolve.c > [2] EPSSetUp() line 263 in > /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/eps/interface/epssetup.c > [2] STSetUp() line 271 in > /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/sys/classes/st/interface/stsolve.c > [2] STSetUp_Sinvert() line 132 in > /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/sys/classes/st/impls/sinvert/sinvert.c > [2] KSPSetUp() line 381 in > /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/ksp/interface/itfunc.c > [2] PCSetUp() line 923 in > /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/pc/interface/precon.c > [2] PCSetUp_LU() line 113 in > /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/pc/impls/factor/lu/lu.c > [2] MatGetFactor() line 4332 in > /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/mat/interface/matrix.c > [2] See > http://www.mcs.anl.gov/petsc/documentation/linearsolvertable.html > for possible LU and Cholesky solvers > [2] MatSolverType mumps does not support matrix type shell I also tried setting up the preconditioner in advance, but that didn't work either and produced the same errors as above: pc = PETSc.PC().create(comm=PETSc.COMM_WORLD) pc.setOperators(A_Shell, P) pc.setFromOptions() pc.setUp() E = SLEPc.EPS().create(comm=PETSc.COMM_WORLD) E.setOperators(A_Shell, B) E.setProblemType(SLEPc.EPS.ProblemType.GNHEP) ksp = E.getKSP() ksp.setPC(pc) E.setFromOptions() E.solve() If I simply try to solve a KSP with those two matrices, it works without any problems. From jroman at dsic.upv.es Wed Aug 1 03:23:46 2018 From: jroman at dsic.upv.es (Jose E. Roman) Date: Wed, 1 Aug 2018 10:23:46 +0200 Subject: [petsc-users] slepc4py - Using shell matrix and explicit preconditioning matrix to solve EPS In-Reply-To: References: Message-ID: <164E9DD6-FF5C-47D5-AF26-828DB773A5E0@dsic.upv.es> Try calling E.setUp() before replacing the matrix. But note that E.setUp() will try to build the preconditioner, so you will have to set PC=none and later change it to lu. Also note that in Krylov methods with exact shift-and-invert (LU) the preconditioner matrix should be exactly the same as A-sigma*B, otherwise you may get unexpected results. Davidson-type methods allow using a different preconditioner. Jose > El 1 ago 2018, a las 10:11, Michael Werner escribi?: > > Hello, > > I'm trying to find the smallest eigenvalues of a linear system created by CFD simulations. To reduce memory requirements, I want to use a shell matrix (A_Shell) to provide the matrix-vector product, and a lower-order explicit matrix (P) as preconditioner. As I'm solving a generalized problem, I'm also passing a second explicit matrix (B) to the EPS. However, I don't see a way to provide the explicit preconditioning matrix to the EPS. > > I'm using the following options: -st_type sinvert -st_pc_type lu -st_matmode shell -eps_target 0.01 -eps_target_real My Python code looks like this: > > E = SLEPc.EPS().create(comm=PETSc.COMM_WORLD) > E.setOperators(A_Shell, B) > E.setProblemType(SLEPc.EPS.ProblemType.GNHEP) > st = E.getST() > ksp = st.getKSP() > pc = ksp.getPC() > pc.setOperators(A_Shell, P) > E.setFromOptions() > E.solve() > > If I run this, I get the following error: >> Error: error code 92 >> [2] EPSSolve() line 135 in /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/eps/interface/epssolve.c >> [2] EPSSetUp() line 263 in /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/eps/interface/epssetup.c >> [2] STSetUp() line 271 in /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/sys/classes/st/interface/stsolve.c >> [2] STSetUp_Sinvert() line 132 in /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/sys/classes/st/impls/sinvert/sinvert.c >> [2] KSPSetUp() line 381 in /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/ksp/interface/itfunc.c >> [2] PCSetUp() line 923 in /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/pc/interface/precon.c >> [2] PCSetUp_LU() line 113 in /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/pc/impls/factor/lu/lu.c >> [2] MatGetFactor() line 4332 in /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/mat/interface/matrix.c >> [2] See http://www.mcs.anl.gov/petsc/documentation/linearsolvertable.html for possible LU and Cholesky solvers >> [2] MatSolverType mumps does not support matrix type shell > > I also tried setting up the preconditioner in advance, but that didn't work either and produced the same errors as above: > > pc = PETSc.PC().create(comm=PETSc.COMM_WORLD) > pc.setOperators(A_Shell, P) > pc.setFromOptions() > pc.setUp() > > E = SLEPc.EPS().create(comm=PETSc.COMM_WORLD) > E.setOperators(A_Shell, B) > E.setProblemType(SLEPc.EPS.ProblemType.GNHEP) > ksp = E.getKSP() > ksp.setPC(pc) > E.setFromOptions() > E.solve() > > If I simply try to solve a KSP with those two matrices, it works without any problems. From michael.werner at dlr.de Wed Aug 1 03:43:28 2018 From: michael.werner at dlr.de (Michael Werner) Date: Wed, 1 Aug 2018 10:43:28 +0200 Subject: [petsc-users] slepc4py - Using shell matrix and explicit preconditioning matrix to solve EPS In-Reply-To: <164E9DD6-FF5C-47D5-AF26-828DB773A5E0@dsic.upv.es> References: <164E9DD6-FF5C-47D5-AF26-828DB773A5E0@dsic.upv.es> Message-ID: Thanks for the quick reply, your suggestion worked perfect. Concerning your remark about Davidson-type methods: I already tried that, however I had problems getting them to converge to the expected eigenvalues. Even when I was using the full explicit system matrix and the options suggested in the slepc manual (-st_type precond -eps_type jd -st_pc_type asm -st_ksp_type bcgsl -st_ksp_rtol 0.001 -eps_target 0.01 -eps_target_real), the results were always "hit-and-miss", the results didn't reliably converge towards the eigenvalues suggested by the exact shift-and-invert. Kind regards, Michael Jose E. Roman writes: > Try calling E.setUp() before replacing the matrix. But note that > E.setUp() will try to build the preconditioner, so you will have > to set PC=none and later change it to lu. > > Also note that in Krylov methods with exact shift-and-invert > (LU) the preconditioner matrix should be exactly the same as > A-sigma*B, otherwise you may get unexpected > results. Davidson-type methods allow using a different > preconditioner. > > Jose > >> El 1 ago 2018, a las 10:11, Michael Werner >> escribi?: >> >> Hello, >> >> I'm trying to find the smallest eigenvalues of a linear system >> created by CFD simulations. To reduce memory requirements, I >> want to use a shell matrix (A_Shell) to provide the >> matrix-vector product, and a lower-order explicit matrix (P) as >> preconditioner. As I'm solving a generalized problem, I'm also >> passing a second explicit matrix (B) to the EPS. However, I >> don't see a way to provide the explicit preconditioning matrix >> to the EPS. >> >> I'm using the following options: -st_type sinvert -st_pc_type >> lu -st_matmode shell -eps_target 0.01 -eps_target_real My >> Python code looks like this: >> >> E = SLEPc.EPS().create(comm=PETSc.COMM_WORLD) >> E.setOperators(A_Shell, B) >> E.setProblemType(SLEPc.EPS.ProblemType.GNHEP) >> st = E.getST() >> ksp = st.getKSP() >> pc = ksp.getPC() >> pc.setOperators(A_Shell, P) >> E.setFromOptions() >> E.solve() >> >> If I run this, I get the following error: >>> Error: error code 92 >>> [2] EPSSolve() line 135 in >>> /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/eps/interface/epssolve.c >>> [2] EPSSetUp() line 263 in >>> /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/eps/interface/epssetup.c >>> [2] STSetUp() line 271 in >>> /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/sys/classes/st/interface/stsolve.c >>> [2] STSetUp_Sinvert() line 132 in >>> /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/sys/classes/st/impls/sinvert/sinvert.c >>> [2] KSPSetUp() line 381 in >>> /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/ksp/interface/itfunc.c >>> [2] PCSetUp() line 923 in >>> /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/pc/interface/precon.c >>> [2] PCSetUp_LU() line 113 in >>> /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/pc/impls/factor/lu/lu.c >>> [2] MatGetFactor() line 4332 in >>> /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/mat/interface/matrix.c >>> [2] See >>> http://www.mcs.anl.gov/petsc/documentation/linearsolvertable.html >>> for possible LU and Cholesky solvers >>> [2] MatSolverType mumps does not support matrix type shell >> >> I also tried setting up the preconditioner in advance, but that >> didn't work either and produced the same errors as above: >> >> pc = PETSc.PC().create(comm=PETSc.COMM_WORLD) >> pc.setOperators(A_Shell, P) >> pc.setFromOptions() >> pc.setUp() >> >> E = SLEPc.EPS().create(comm=PETSc.COMM_WORLD) >> E.setOperators(A_Shell, B) >> E.setProblemType(SLEPc.EPS.ProblemType.GNHEP) >> ksp = E.getKSP() >> ksp.setPC(pc) >> E.setFromOptions() >> E.solve() >> >> If I simply try to solve a KSP with those two matrices, it >> works without any problems. From jroman at dsic.upv.es Wed Aug 1 04:00:23 2018 From: jroman at dsic.upv.es (Jose E. Roman) Date: Wed, 1 Aug 2018 11:00:23 +0200 Subject: [petsc-users] slepc4py - Using shell matrix and explicit preconditioning matrix to solve EPS In-Reply-To: References: <164E9DD6-FF5C-47D5-AF26-828DB773A5E0@dsic.upv.es> Message-ID: If Krylov methods work for you then no need to worry about Davidson methods. JD has many parameters that influence convergence. Also, it relies on having a good preconditioner, maybe ASM is not enough for your problem. Some time ago with we used the pARMS preconditioner, see https://doi.org/10.1016/j.cpc.2011.12.018 - but the results are problem dependent. Also, you can try GD instead of JD, which is simpler and often gives better performance. See a detailed explanation here: https://doi.org/10.1145/2543696 Jose > El 1 ago 2018, a las 10:43, Michael Werner escribi?: > > > Thanks for the quick reply, your suggestion worked perfect. Concerning your remark about Davidson-type methods: I already tried that, however I had problems getting them to converge to the expected eigenvalues. Even when I was using the full explicit system matrix and the options suggested in the slepc manual (-st_type precond -eps_type jd -st_pc_type asm -st_ksp_type bcgsl -st_ksp_rtol 0.001 -eps_target 0.01 -eps_target_real), the results were always "hit-and-miss", the results didn't reliably converge towards the eigenvalues suggested by the exact shift-and-invert. > > Kind regards, > Michael > > Jose E. Roman writes: > >> Try calling E.setUp() before replacing the matrix. But note that E.setUp() will try to build the preconditioner, so you will have to set PC=none and later change it to lu. >> >> Also note that in Krylov methods with exact shift-and-invert (LU) the preconditioner matrix should be exactly the same as A-sigma*B, otherwise you may get unexpected results. Davidson-type methods allow using a different preconditioner. >> >> Jose >> >>> El 1 ago 2018, a las 10:11, Michael Werner escribi?: >>> Hello, >>> I'm trying to find the smallest eigenvalues of a linear system created by CFD simulations. To reduce memory requirements, I want to use a shell matrix (A_Shell) to provide the matrix-vector product, and a lower-order explicit matrix (P) as preconditioner. As I'm solving a generalized problem, I'm also passing a second explicit matrix (B) to the EPS. However, I don't see a way to provide the explicit preconditioning matrix to the EPS. >>> I'm using the following options: -st_type sinvert -st_pc_type lu -st_matmode shell -eps_target 0.01 -eps_target_real My Python code looks like this: >>> E = SLEPc.EPS().create(comm=PETSc.COMM_WORLD) >>> E.setOperators(A_Shell, B) >>> E.setProblemType(SLEPc.EPS.ProblemType.GNHEP) >>> st = E.getST() >>> ksp = st.getKSP() >>> pc = ksp.getPC() >>> pc.setOperators(A_Shell, P) >>> E.setFromOptions() >>> E.solve() >>> If I run this, I get the following error: >>>> Error: error code 92 >>>> [2] EPSSolve() line 135 in /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/eps/interface/epssolve.c >>>> [2] EPSSetUp() line 263 in /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/eps/interface/epssetup.c >>>> [2] STSetUp() line 271 in /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/sys/classes/st/interface/stsolve.c >>>> [2] STSetUp_Sinvert() line 132 in /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/sys/classes/st/impls/sinvert/sinvert.c >>>> [2] KSPSetUp() line 381 in /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/ksp/interface/itfunc.c >>>> [2] PCSetUp() line 923 in /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/pc/interface/precon.c >>>> [2] PCSetUp_LU() line 113 in /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/pc/impls/factor/lu/lu.c >>>> [2] MatGetFactor() line 4332 in /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/mat/interface/matrix.c >>>> [2] See http://www.mcs.anl.gov/petsc/documentation/linearsolvertable.html for possible LU and Cholesky solvers >>>> [2] MatSolverType mumps does not support matrix type shell >>> I also tried setting up the preconditioner in advance, but that didn't work either and produced the same errors as above: >>> pc = PETSc.PC().create(comm=PETSc.COMM_WORLD) >>> pc.setOperators(A_Shell, P) >>> pc.setFromOptions() >>> pc.setUp() >>> E = SLEPc.EPS().create(comm=PETSc.COMM_WORLD) >>> E.setOperators(A_Shell, B) >>> E.setProblemType(SLEPc.EPS.ProblemType.GNHEP) >>> ksp = E.getKSP() >>> ksp.setPC(pc) >>> E.setFromOptions() >>> E.solve() >>> If I simply try to solve a KSP with those two matrices, it works without any problems. > From michael.werner at dlr.de Wed Aug 1 04:05:28 2018 From: michael.werner at dlr.de (Michael Werner) Date: Wed, 1 Aug 2018 11:05:28 +0200 Subject: [petsc-users] slepc4py - Using shell matrix and explicit preconditioning matrix to solve EPS In-Reply-To: References: <164E9DD6-FF5C-47D5-AF26-828DB773A5E0@dsic.upv.es> Message-ID: Interesting, I will have a look at those papers, thank you. I'm still trying to get the Davidson methods to work, because for big matrices I can't use the krylov methods anymore due to limited memory. Kind regards, Michael Jose E. Roman writes: > If Krylov methods work for you then no need to worry about > Davidson methods. JD has many parameters that influence > convergence. Also, it relies on having a good preconditioner, > maybe ASM is not enough for your problem. Some time ago with we > used the pARMS preconditioner, see > https://doi.org/10.1016/j.cpc.2011.12.018 - but the results are > problem dependent. Also, you can try GD instead of JD, which is > simpler and often gives better performance. See a detailed > explanation here: https://doi.org/10.1145/2543696 > > Jose > >> El 1 ago 2018, a las 10:43, Michael Werner >> escribi?: >> >> >> Thanks for the quick reply, your suggestion worked >> perfect. Concerning your remark about Davidson-type methods: I >> already tried that, however I had problems getting them to >> converge to the expected eigenvalues. Even when I was using the >> full explicit system matrix and the options suggested in the >> slepc manual (-st_type precond -eps_type jd -st_pc_type asm >> -st_ksp_type bcgsl -st_ksp_rtol 0.001 -eps_target 0.01 >> -eps_target_real), the results were always "hit-and-miss", the >> results didn't reliably converge towards the eigenvalues >> suggested by the exact shift-and-invert. >> >> Kind regards, >> Michael >> >> Jose E. Roman writes: >> >>> Try calling E.setUp() before replacing the matrix. But note >>> that E.setUp() will try to build the preconditioner, so you >>> will have to set PC=none and later change it to lu. >>> >>> Also note that in Krylov methods with exact shift-and-invert >>> (LU) the preconditioner matrix should be exactly the same as >>> A-sigma*B, otherwise you may get unexpected >>> results. Davidson-type methods allow using a different >>> preconditioner. >>> >>> Jose >>> >>>> El 1 ago 2018, a las 10:11, Michael Werner >>>> escribi?: >>>> Hello, >>>> I'm trying to find the smallest eigenvalues of a linear >>>> system created by CFD simulations. To reduce memory >>>> requirements, I want to use a shell matrix (A_Shell) to >>>> provide the matrix-vector product, and a lower-order explicit >>>> matrix (P) as preconditioner. As I'm solving a generalized >>>> problem, I'm also passing a second explicit matrix (B) to the >>>> EPS. However, I don't see a way to provide the explicit >>>> preconditioning matrix to the EPS. >>>> I'm using the following options: -st_type sinvert -st_pc_type >>>> lu -st_matmode shell -eps_target 0.01 -eps_target_real My >>>> Python code looks like this: >>>> E = SLEPc.EPS().create(comm=PETSc.COMM_WORLD) >>>> E.setOperators(A_Shell, B) >>>> E.setProblemType(SLEPc.EPS.ProblemType.GNHEP) >>>> st = E.getST() >>>> ksp = st.getKSP() >>>> pc = ksp.getPC() >>>> pc.setOperators(A_Shell, P) >>>> E.setFromOptions() >>>> E.solve() >>>> If I run this, I get the following error: >>>>> Error: error code 92 >>>>> [2] EPSSolve() line 135 in >>>>> /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/eps/interface/epssolve.c >>>>> [2] EPSSetUp() line 263 in >>>>> /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/eps/interface/epssetup.c >>>>> [2] STSetUp() line 271 in >>>>> /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/sys/classes/st/interface/stsolve.c >>>>> [2] STSetUp_Sinvert() line 132 in >>>>> /home/conda/feedstock_root/build_artifacts/slepc_1531127798016/work/src/sys/classes/st/impls/sinvert/sinvert.c >>>>> [2] KSPSetUp() line 381 in >>>>> /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/ksp/interface/itfunc.c >>>>> [2] PCSetUp() line 923 in >>>>> /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/pc/interface/precon.c >>>>> [2] PCSetUp_LU() line 113 in >>>>> /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/ksp/pc/impls/factor/lu/lu.c >>>>> [2] MatGetFactor() line 4332 in >>>>> /home/conda/feedstock_root/build_artifacts/petsc_1530637062977/work/src/mat/interface/matrix.c >>>>> [2] See >>>>> http://www.mcs.anl.gov/petsc/documentation/linearsolvertable.html >>>>> for possible LU and Cholesky solvers >>>>> [2] MatSolverType mumps does not support matrix type shell >>>> I also tried setting up the preconditioner in advance, but >>>> that didn't work either and produced the same errors as >>>> above: >>>> pc = PETSc.PC().create(comm=PETSc.COMM_WORLD) >>>> pc.setOperators(A_Shell, P) >>>> pc.setFromOptions() >>>> pc.setUp() >>>> E = SLEPc.EPS().create(comm=PETSc.COMM_WORLD) >>>> E.setOperators(A_Shell, B) >>>> E.setProblemType(SLEPc.EPS.ProblemType.GNHEP) >>>> ksp = E.getKSP() >>>> ksp.setPC(pc) >>>> E.setFromOptions() >>>> E.solve() >>>> If I simply try to solve a KSP with those two matrices, it >>>> works without any problems. >> From pierpaolo.minelli at cnr.it Wed Aug 1 08:01:03 2018 From: pierpaolo.minelli at cnr.it (Pierpaolo Minelli) Date: Wed, 1 Aug 2018 15:01:03 +0200 Subject: [petsc-users] Solving Linear Systems with Scalar Real and Complex In-Reply-To: <0ECD0720-31CA-443F-A44C-6703063B26B5@anl.gov> References: <405250E7-D339-4F7A-BD0D-B008D6B3FC8D@cnr.it> <3B4B622A-EBCE-4E61-9039-CA8C34F730A4@cnr.it> <0ECD0720-31CA-443F-A44C-6703063B26B5@anl.gov> Message-ID: <583A6898-B577-495D-96C9-FFABA14B5B8D@cnr.it> > Il giorno 27 lug 2018, alle ore 18:32, Smith, Barry F. ha scritto: > > > >> On Jul 27, 2018, at 3:26 AM, Pierpaolo Minelli wrote: >> >> >> Finally, I have a question. In my simulation I solve the two systems at each step of the calculation, and it was my habit to use the following option after the first resolution and before solving the system in the second time step: >> >> call KSPSetInitialGuessNonzero(ksp,PETSC_TRUE,ierr) >> >> Since this option was incompatible with the use of MUMPS or SuperLU_Dist, I commented on it and noticed, to my surprise, that iterative methods were not affected by this comment, rather they were slightly faster. Is this normal? Or do I use this command incorrectly? > > Presuming this is a linear problem? > > You should run with -ksp_monitor_true_residual and compare the final residual norms (at linear system convergence). Since KSP uses a relative decrease in the residual norm to declare convergence what you have told us isn't enough to determine if one is converging "faster" to the solution then the other. > > Barry Yes, there are two linear problems. The first in the field of complex numbers (which I divided into two problems in the field of real numbers as suggested by Matthew) and the second in the field of real numbers. These are the results obtained using the option -ksp_monitor_true_residual: -pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 -ksp_monitor_true_residual 0 KSP preconditioned resid norm 1.324344286254e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.399266083153e-03 true resid norm 1.196951495628e+05 ||r(i)||/||b|| 4.016796777391e+07 2 KSP preconditioned resid norm 6.287919852336e-04 true resid norm 4.429876706490e+04 ||r(i)||/||b|| 1.486602802524e+07 3 KSP preconditioned resid norm 8.836547690039e-05 true resid norm 1.182383826632e+04 ||r(i)||/||b|| 3.967909778970e+06 4 KSP preconditioned resid norm 1.291370058561e-05 true resid norm 2.801893692950e+03 ||r(i)||/||b|| 9.402751571421e+05 5 KSP preconditioned resid norm 2.073922228951e-06 true resid norm 6.312112895919e+02 ||r(i)||/||b|| 2.118254150770e+05 6 KSP preconditioned resid norm 3.283811876800e-07 true resid norm 8.777865833701e+01 ||r(i)||/||b|| 2.945725313178e+04 7 KSP preconditioned resid norm 5.414680273500e-08 true resid norm 1.610127004050e+01 ||r(i)||/||b|| 5.403354258448e+03 8 KSP preconditioned resid norm 9.645834363683e-09 true resid norm 3.006444251909e+00 ||r(i)||/||b|| 1.008919377818e+03 9 KSP preconditioned resid norm 1.915420455785e-09 true resid norm 6.672996533262e-01 ||r(i)||/||b|| 2.239361500298e+02 10 KSP preconditioned resid norm 3.334928638696e-10 true resid norm 1.185976397497e-01 ||r(i)||/||b|| 3.979965929219e+01 0 KSP preconditioned resid norm 1.416256896904e+04 true resid norm 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.781264980774e+03 true resid norm 1.283809201228e+11 ||r(i)||/||b|| 1.938227104995e+05 2 KSP preconditioned resid norm 7.392413714593e+02 true resid norm 4.990467508600e+10 ||r(i)||/||b|| 7.534343407504e+04 3 KSP preconditioned resid norm 1.087641767696e+02 true resid norm 1.367263690390e+10 ||r(i)||/||b|| 2.064222270610e+04 4 KSP preconditioned resid norm 1.627726591174e+01 true resid norm 3.451534923895e+09 ||r(i)||/||b|| 5.210944536719e+03 5 KSP preconditioned resid norm 2.564636460142e+00 true resid norm 7.980525032990e+08 ||r(i)||/||b|| 1.204857381941e+03 6 KSP preconditioned resid norm 4.252626820180e-01 true resid norm 1.151817528111e+08 ||r(i)||/||b|| 1.738953070953e+02 7 KSP preconditioned resid norm 6.758292325957e-02 true resid norm 2.065701091779e+07 ||r(i)||/||b|| 3.118686050134e+01 8 KSP preconditioned resid norm 1.099617201063e-02 true resid norm 3.470561062696e+06 ||r(i)||/||b|| 5.239669192917e+00 9 KSP preconditioned resid norm 2.195352537111e-03 true resid norm 7.056823048483e+05 ||r(i)||/||b|| 1.065401750871e+00 10 KSP preconditioned resid norm 4.380752631896e-04 true resid norm 1.440377395627e+05 ||r(i)||/||b|| 2.174605468598e-01 0 KSP preconditioned resid norm 4.970534641714e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 9.825390294838e+01 true resid norm 6.304087699909e+03 ||r(i)||/||b|| 3.354169267824e+01 2 KSP preconditioned resid norm 1.317425630977e+01 true resid norm 1.659038483292e+03 ||r(i)||/||b|| 8.827123224947e+00 3 KSP preconditioned resid norm 1.267331175258e+00 true resid norm 3.723773819327e+02 ||r(i)||/||b|| 1.981280765700e+00 4 KSP preconditioned resid norm 1.451198865319e-01 true resid norm 6.113281457366e+01 ||r(i)||/||b|| 3.252648403059e-01 5 KSP preconditioned resid norm 2.428012832580e-02 true resid norm 9.525516489005e+00 ||r(i)||/||b|| 5.068171032587e-02 6 KSP preconditioned resid norm 3.273131599046e-03 true resid norm 1.693121214500e+00 ||r(i)||/||b|| 9.008464689439e-03 7 KSP preconditioned resid norm 3.629020564958e-04 true resid norm 1.937921370699e-01 ||r(i)||/||b|| 1.031095475584e-03 8 KSP preconditioned resid norm 4.303742583350e-05 true resid norm 2.733022203972e-02 ||r(i)||/||b|| 1.454138889117e-04 -pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual 0 KSP preconditioned resid norm 1.825767020537e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 6.495628259378e-04 true resid norm 1.373525306349e+04 ||r(i)||/||b|| 4.609353047603e+06 2 KSP preconditioned resid norm 4.971875712010e-05 true resid norm 2.154150315236e+03 ||r(i)||/||b|| 7.229018114651e+05 3 KSP preconditioned resid norm 3.726806462903e-06 true resid norm 3.000693510070e+02 ||r(i)||/||b|| 1.006989511706e+05 4 KSP preconditioned resid norm 2.496898447113e-07 true resid norm 3.004338446358e+01 ||r(i)||/||b|| 1.008212699813e+04 5 KSP preconditioned resid norm 1.541814409235e-08 true resid norm 2.256927674575e+00 ||r(i)||/||b|| 7.573924125705e+02 6 KSP preconditioned resid norm 1.153890845088e-09 true resid norm 2.007294077611e-01 ||r(i)||/||b|| 6.736189738408e+01 0 KSP preconditioned resid norm 1.961448048638e+04 true resid norm 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 7.940694187362e+02 true resid norm 1.483756468402e+10 ||r(i)||/||b|| 2.240096894085e+04 2 KSP preconditioned resid norm 6.141876183549e+01 true resid norm 2.581042149104e+09 ||r(i)||/||b|| 3.896720671376e+03 3 KSP preconditioned resid norm 4.872887149903e+00 true resid norm 3.544664743366e+08 ||r(i)||/||b|| 5.351547003355e+02 4 KSP preconditioned resid norm 3.088357668912e-01 true resid norm 3.689655474675e+07 ||r(i)||/||b|| 5.570446326655e+01 5 KSP preconditioned resid norm 2.030016543101e-02 true resid norm 2.847019997470e+06 ||r(i)||/||b|| 4.298279933093e+00 6 KSP preconditioned resid norm 1.458276940703e-03 true resid norm 2.567051860886e+05 ||r(i)||/||b|| 3.875598875547e-01 0 KSP preconditioned resid norm 6.230592591466e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.825349376322e+01 true resid norm 7.755266613308e+02 ||r(i)||/||b|| 4.126287287931e+00 2 KSP preconditioned resid norm 4.321561767174e+00 true resid norm 2.170558998883e+02 ||r(i)||/||b|| 1.154873255992e+00 3 KSP preconditioned resid norm 2.806349660119e-01 true resid norm 2.931496742303e+01 ||r(i)||/||b|| 1.559739767247e-01 4 KSP preconditioned resid norm 1.707567397460e-02 true resid norm 2.684913551118e+00 ||r(i)||/||b|| 1.428542074383e-02 5 KSP preconditioned resid norm 1.741069717192e-03 true resid norm 2.914639372698e-01 ||r(i)||/||b|| 1.550770591410e-03 6 KSP preconditioned resid norm 1.460913620440e-04 true resid norm 3.460791330512e-02 ||r(i)||/||b|| 1.841357619965e-04 7 KSP preconditioned resid norm 1.741167177387e-05 true resid norm 3.396573365236e-03 ||r(i)||/||b|| 1.807189642642e-05 -pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual 0 KSP preconditioned resid norm 1.984853668903e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.924446712660e-04 true resid norm 8.461145171168e+03 ||r(i)||/||b|| 2.839438421750e+06 2 KSP preconditioned resid norm 5.161509100761e-06 true resid norm 4.501007519328e+02 ||r(i)||/||b|| 1.510473278548e+05 3 KSP preconditioned resid norm 9.297326931235e-08 true resid norm 1.474595580807e+01 ||r(i)||/||b|| 4.948530327732e+03 4 KSP preconditioned resid norm 1.910271882618e-09 true resid norm 3.603243780988e-01 ||r(i)||/||b|| 1.209196701829e+02 0 KSP preconditioned resid norm 2.157687745804e+04 true resid norm 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.949268476385e+02 true resid norm 8.974916757495e+09 ||r(i)||/||b|| 1.354985375382e+04 2 KSP preconditioned resid norm 5.078054475786e+00 true resid norm 4.502684440161e+08 ||r(i)||/||b|| 6.797914377626e+02 3 KSP preconditioned resid norm 8.663802743525e-02 true resid norm 1.432117031381e+07 ||r(i)||/||b|| 2.162134408362e+01 4 KSP preconditioned resid norm 1.795605563041e-03 true resid norm 3.389868548833e+05 ||r(i)||/||b|| 5.117843911255e-01 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 Thanks Pierpaolo >> >> Thanks >> >> Pierpaolo >> >>> Il giorno 23 lug 2018, alle ore 15:43, Mark Adams ha scritto: >>> >>> Note, as Barry said, GAMG works with native complex numbers. You can start with your original complex build and use '-pc_type gamg'. >>> Mark >>> >>> On Mon, Jul 23, 2018 at 6:52 AM Pierpaolo Minelli wrote: >>> >>> >>>> Il giorno 20 lug 2018, alle ore 19:58, Smith, Barry F. ha scritto: >>>> >>>> >>>> >>>>> On Jul 20, 2018, at 7:01 AM, Pierpaolo Minelli wrote: >>>>> >>>>> Hi, >>>>> >>>>> in my code I have to solve both a system in the field of real numbers and in the field of complex numbers. >>>>> My approach has been as follows. >>>>> First I configured PETSc with the --with-scalar-type=complex option. >>>>> Using this option I have unfortunately lost the possibility to use the two preconditioners ML and Hypre. >>>> >>>> You should still be able to use the PETSc PCGAMG algebraic multigrid solver. Have you tried that? If there are issues let us know because we would like to continue to improve the performance of PCGAMG to get it to be closer to as good as ML and hypre. >>>> >>>> Barry >>>> >>> >>> I will try to convert, as suggested by Matthew, my complex system in a system twice as large in real numbers. When i finish, i will try to use ML, Hypre and GAMG and i let you know if there are any performance differences. >>> >>> Thanks >>> >>> Pierpaolo >>> >>> >>>>> I later created two subspaces of Krylov and tried to solve the two systems as I used to when solving the only equation in the real numbers field. >>>>> In order to correctly solve the system in the field of real numbers I had to transform the coefficients from real to complex with an imaginary part equal to zero. >>>>> >>>>> Is there a possibility to use a different and better approach to solve my problem? >>>>> >>>>> Perhaps an approach where you can continue to use ML and Hypre for system solving in the real numbers field or where you don't need to use complex numbers when real numbers would actually suffice? >>>>> >>>>> Thanks in advance >>>>> >>>>> Pierpaolo >>>>> >>>> >>> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 1 08:41:51 2018 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 1 Aug 2018 09:41:51 -0400 Subject: [petsc-users] Solving Linear Systems with Scalar Real and Complex In-Reply-To: <583A6898-B577-495D-96C9-FFABA14B5B8D@cnr.it> References: <405250E7-D339-4F7A-BD0D-B008D6B3FC8D@cnr.it> <3B4B622A-EBCE-4E61-9039-CA8C34F730A4@cnr.it> <0ECD0720-31CA-443F-A44C-6703063B26B5@anl.gov> <583A6898-B577-495D-96C9-FFABA14B5B8D@cnr.it> Message-ID: On Wed, Aug 1, 2018 at 9:02 AM Pierpaolo Minelli wrote: > Il giorno 27 lug 2018, alle ore 18:32, Smith, Barry F. > ha scritto: > > On Jul 27, 2018, at 3:26 AM, Pierpaolo Minelli > wrote: > > > Finally, I have a question. In my simulation I solve the two systems at > each step of the calculation, and it was my habit to use the following > option after the first resolution and before solving the system in the > second time step: > > call KSPSetInitialGuessNonzero(ksp,PETSC_TRUE,ierr) > > Since this option was incompatible with the use of MUMPS or SuperLU_Dist, > I commented on it and noticed, to my surprise, that iterative methods were > not affected by this comment, rather they were slightly faster. Is this > normal? Or do I use this command incorrectly? > > > Presuming this is a linear problem? > > > You should run with -ksp_monitor_true_residual and compare the final > residual norms (at linear system convergence). Since KSP uses a relative > decrease in the residual norm to declare convergence what you have told us > isn't enough to determine if one is converging "faster" to the solution > then the other. > > Barry > > > Yes, there are two linear problems. The first in the field of complex > numbers (which I divided into two problems in the field of real numbers as > suggested by Matthew) and the second in the field of real numbers. > > These are the results obtained using the option -ksp_monitor_true_residual: > > *-pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true > -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 > -ksp_monitor_true_residual* > > 0 KSP preconditioned resid norm 1.324344286254e-02 true resid norm > 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.399266083153e-03 true resid norm > 1.196951495628e+05 ||r(i)||/||b|| 4.016796777391e+07 > 2 KSP preconditioned resid norm 6.287919852336e-04 true resid norm > 4.429876706490e+04 ||r(i)||/||b|| 1.486602802524e+07 > 3 KSP preconditioned resid norm 8.836547690039e-05 true resid norm > 1.182383826632e+04 ||r(i)||/||b|| 3.967909778970e+06 > 4 KSP preconditioned resid norm 1.291370058561e-05 true resid norm > 2.801893692950e+03 ||r(i)||/||b|| 9.402751571421e+05 > 5 KSP preconditioned resid norm 2.073922228951e-06 true resid norm > 6.312112895919e+02 ||r(i)||/||b|| 2.118254150770e+05 > 6 KSP preconditioned resid norm 3.283811876800e-07 true resid norm > 8.777865833701e+01 ||r(i)||/||b|| 2.945725313178e+04 > 7 KSP preconditioned resid norm 5.414680273500e-08 true resid norm > 1.610127004050e+01 ||r(i)||/||b|| 5.403354258448e+03 > 8 KSP preconditioned resid norm 9.645834363683e-09 true resid norm > 3.006444251909e+00 ||r(i)||/||b|| 1.008919377818e+03 > 9 KSP preconditioned resid norm 1.915420455785e-09 true resid norm > 6.672996533262e-01 ||r(i)||/||b|| 2.239361500298e+02 > 10 KSP preconditioned resid norm 3.334928638696e-10 true resid norm > 1.185976397497e-01 ||r(i)||/||b|| 3.979965929219e+01 > You can see from the "true resid norm" that your complex problem is not actually being solved. ML and Hypre have similar results. I would guess that your coarse grid is near singular. The real problem is being solved correctly, although you are still 100x off the true residual so the preconditioner is not great. Have you tested with a manufactured solution? Thanks, Matt > 0 KSP preconditioned resid norm 1.416256896904e+04 true resid norm > 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.781264980774e+03 true resid norm > 1.283809201228e+11 ||r(i)||/||b|| 1.938227104995e+05 > 2 KSP preconditioned resid norm 7.392413714593e+02 true resid norm > 4.990467508600e+10 ||r(i)||/||b|| 7.534343407504e+04 > 3 KSP preconditioned resid norm 1.087641767696e+02 true resid norm > 1.367263690390e+10 ||r(i)||/||b|| 2.064222270610e+04 > 4 KSP preconditioned resid norm 1.627726591174e+01 true resid norm > 3.451534923895e+09 ||r(i)||/||b|| 5.210944536719e+03 > 5 KSP preconditioned resid norm 2.564636460142e+00 true resid norm > 7.980525032990e+08 ||r(i)||/||b|| 1.204857381941e+03 > 6 KSP preconditioned resid norm 4.252626820180e-01 true resid norm > 1.151817528111e+08 ||r(i)||/||b|| 1.738953070953e+02 > 7 KSP preconditioned resid norm 6.758292325957e-02 true resid norm > 2.065701091779e+07 ||r(i)||/||b|| 3.118686050134e+01 > 8 KSP preconditioned resid norm 1.099617201063e-02 true resid norm > 3.470561062696e+06 ||r(i)||/||b|| 5.239669192917e+00 > 9 KSP preconditioned resid norm 2.195352537111e-03 true resid norm > 7.056823048483e+05 ||r(i)||/||b|| 1.065401750871e+00 > 10 KSP preconditioned resid norm 4.380752631896e-04 true resid norm > 1.440377395627e+05 ||r(i)||/||b|| 2.174605468598e-01 > > 0 KSP preconditioned resid norm 4.970534641714e+02 true resid norm > 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 9.825390294838e+01 true resid norm > 6.304087699909e+03 ||r(i)||/||b|| 3.354169267824e+01 > 2 KSP preconditioned resid norm 1.317425630977e+01 true resid norm > 1.659038483292e+03 ||r(i)||/||b|| 8.827123224947e+00 > 3 KSP preconditioned resid norm 1.267331175258e+00 true resid norm > 3.723773819327e+02 ||r(i)||/||b|| 1.981280765700e+00 > 4 KSP preconditioned resid norm 1.451198865319e-01 true resid norm > 6.113281457366e+01 ||r(i)||/||b|| 3.252648403059e-01 > 5 KSP preconditioned resid norm 2.428012832580e-02 true resid norm > 9.525516489005e+00 ||r(i)||/||b|| 5.068171032587e-02 > 6 KSP preconditioned resid norm 3.273131599046e-03 true resid norm > 1.693121214500e+00 ||r(i)||/||b|| 9.008464689439e-03 > 7 KSP preconditioned resid norm 3.629020564958e-04 true resid norm > 1.937921370699e-01 ||r(i)||/||b|| 1.031095475584e-03 > 8 KSP preconditioned resid norm 4.303742583350e-05 true resid norm > 2.733022203972e-02 ||r(i)||/||b|| 1.454138889117e-04 > > *-pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual* > > 0 KSP preconditioned resid norm 1.825767020537e-02 true resid norm > 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 6.495628259378e-04 true resid norm > 1.373525306349e+04 ||r(i)||/||b|| 4.609353047603e+06 > 2 KSP preconditioned resid norm 4.971875712010e-05 true resid norm > 2.154150315236e+03 ||r(i)||/||b|| 7.229018114651e+05 > 3 KSP preconditioned resid norm 3.726806462903e-06 true resid norm > 3.000693510070e+02 ||r(i)||/||b|| 1.006989511706e+05 > 4 KSP preconditioned resid norm 2.496898447113e-07 true resid norm > 3.004338446358e+01 ||r(i)||/||b|| 1.008212699813e+04 > 5 KSP preconditioned resid norm 1.541814409235e-08 true resid norm > 2.256927674575e+00 ||r(i)||/||b|| 7.573924125705e+02 > 6 KSP preconditioned resid norm 1.153890845088e-09 true resid norm > 2.007294077611e-01 ||r(i)||/||b|| 6.736189738408e+01 > 0 KSP preconditioned resid norm 1.961448048638e+04 true resid norm > 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.940694187362e+02 true resid norm > 1.483756468402e+10 ||r(i)||/||b|| 2.240096894085e+04 > 2 KSP preconditioned resid norm 6.141876183549e+01 true resid norm > 2.581042149104e+09 ||r(i)||/||b|| 3.896720671376e+03 > 3 KSP preconditioned resid norm 4.872887149903e+00 true resid norm > 3.544664743366e+08 ||r(i)||/||b|| 5.351547003355e+02 > 4 KSP preconditioned resid norm 3.088357668912e-01 true resid norm > 3.689655474675e+07 ||r(i)||/||b|| 5.570446326655e+01 > 5 KSP preconditioned resid norm 2.030016543101e-02 true resid norm > 2.847019997470e+06 ||r(i)||/||b|| 4.298279933093e+00 > 6 KSP preconditioned resid norm 1.458276940703e-03 true resid norm > 2.567051860886e+05 ||r(i)||/||b|| 3.875598875547e-01 > > 0 KSP preconditioned resid norm 6.230592591466e+02 true resid norm > 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.825349376322e+01 true resid norm > 7.755266613308e+02 ||r(i)||/||b|| 4.126287287931e+00 > 2 KSP preconditioned resid norm 4.321561767174e+00 true resid norm > 2.170558998883e+02 ||r(i)||/||b|| 1.154873255992e+00 > 3 KSP preconditioned resid norm 2.806349660119e-01 true resid norm > 2.931496742303e+01 ||r(i)||/||b|| 1.559739767247e-01 > 4 KSP preconditioned resid norm 1.707567397460e-02 true resid norm > 2.684913551118e+00 ||r(i)||/||b|| 1.428542074383e-02 > 5 KSP preconditioned resid norm 1.741069717192e-03 true resid norm > 2.914639372698e-01 ||r(i)||/||b|| 1.550770591410e-03 > 6 KSP preconditioned resid norm 1.460913620440e-04 true resid norm > 3.460791330512e-02 ||r(i)||/||b|| 1.841357619965e-04 > 7 KSP preconditioned resid norm 1.741167177387e-05 true resid norm > 3.396573365236e-03 ||r(i)||/||b|| 1.807189642642e-05 > > *-pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual* > > 0 KSP preconditioned resid norm 1.984853668903e-02 true resid norm > 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.924446712660e-04 true resid norm > 8.461145171168e+03 ||r(i)||/||b|| 2.839438421750e+06 > 2 KSP preconditioned resid norm 5.161509100761e-06 true resid norm > 4.501007519328e+02 ||r(i)||/||b|| 1.510473278548e+05 > 3 KSP preconditioned resid norm 9.297326931235e-08 true resid norm > 1.474595580807e+01 ||r(i)||/||b|| 4.948530327732e+03 > 4 KSP preconditioned resid norm 1.910271882618e-09 true resid norm > 3.603243780988e-01 ||r(i)||/||b|| 1.209196701829e+02 > 0 KSP preconditioned resid norm 2.157687745804e+04 true resid norm > 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.949268476385e+02 true resid norm > 8.974916757495e+09 ||r(i)||/||b|| 1.354985375382e+04 > 2 KSP preconditioned resid norm 5.078054475786e+00 true resid norm > 4.502684440161e+08 ||r(i)||/||b|| 6.797914377626e+02 > 3 KSP preconditioned resid norm 8.663802743525e-02 true resid norm > 1.432117031381e+07 ||r(i)||/||b|| 2.162134408362e+01 > 4 KSP preconditioned resid norm 1.795605563041e-03 true resid norm > 3.389868548833e+05 ||r(i)||/||b|| 5.117843911255e-01 > > 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm > 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm > 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 > 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm > 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 > 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm > 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 > 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm > 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 > 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm > 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 > > Thanks > > Pierpaolo > > > Thanks > > Pierpaolo > > Il giorno 23 lug 2018, alle ore 15:43, Mark Adams ha > scritto: > > Note, as Barry said, GAMG works with native complex numbers. You can start > with your original complex build and use '-pc_type gamg'. > Mark > > On Mon, Jul 23, 2018 at 6:52 AM Pierpaolo Minelli < > pierpaolo.minelli at cnr.it> wrote: > > > Il giorno 20 lug 2018, alle ore 19:58, Smith, Barry F. > ha scritto: > > > > On Jul 20, 2018, at 7:01 AM, Pierpaolo Minelli > wrote: > > Hi, > > in my code I have to solve both a system in the field of real numbers and > in the field of complex numbers. > My approach has been as follows. > First I configured PETSc with the --with-scalar-type=complex option. > Using this option I have unfortunately lost the possibility to use the two > preconditioners ML and Hypre. > > > You should still be able to use the PETSc PCGAMG algebraic multigrid > solver. Have you tried that? If there are issues let us know because we > would like to continue to improve the performance of PCGAMG to get it to be > closer to as good as ML and hypre. > > Barry > > > I will try to convert, as suggested by Matthew, my complex system in a > system twice as large in real numbers. When i finish, i will try to use ML, > Hypre and GAMG and i let you know if there are any performance differences. > > Thanks > > Pierpaolo > > > I later created two subspaces of Krylov and tried to solve the two systems > as I used to when solving the only equation in the real numbers field. > In order to correctly solve the system in the field of real numbers I had > to transform the coefficients from real to complex with an imaginary part > equal to zero. > > Is there a possibility to use a different and better approach to solve my > problem? > > Perhaps an approach where you can continue to use ML and Hypre for system > solving in the real numbers field or where you don't need to use complex > numbers when real numbers would actually suffice? > > Thanks in advance > > Pierpaolo > > > > > > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From pierpaolo.minelli at cnr.it Thu Aug 2 05:06:30 2018 From: pierpaolo.minelli at cnr.it (Pierpaolo Minelli) Date: Thu, 2 Aug 2018 12:06:30 +0200 Subject: [petsc-users] Solving Linear Systems with Scalar Real and Complex In-Reply-To: References: <405250E7-D339-4F7A-BD0D-B008D6B3FC8D@cnr.it> <3B4B622A-EBCE-4E61-9039-CA8C34F730A4@cnr.it> <0ECD0720-31CA-443F-A44C-6703063B26B5@anl.gov> <583A6898-B577-495D-96C9-FFABA14B5B8D@cnr.it> Message-ID: Thank you very much for the correction. By rebalancing the matrix coefficients, making them dimensionless, in my complex problem i managed to obtain a better result with both ML and HYPRE. GAMG instead seems to be unable to converge and in fact I get unexpected results. I report the outputs of the three simulations again (i tried to use also -pc_gamg_square_graph 20 without any improvement). Pierpaolo -pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual 0 KSP preconditioned resid norm 1.984853668904e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.924446712661e-04 true resid norm 1.204260204811e-04 ||r(i)||/||b|| 4.041323752460e-02 2 KSP preconditioned resid norm 5.161509100765e-06 true resid norm 2.810809726926e-06 ||r(i)||/||b|| 9.432672496933e-04 3 KSP preconditioned resid norm 9.297326931238e-08 true resid norm 4.474617977876e-08 ||r(i)||/||b|| 1.501617328625e-05 4 KSP preconditioned resid norm 1.910271882670e-09 true resid norm 9.637470658283e-10 ||r(i)||/||b|| 3.234196308186e-07 0 KSP preconditioned resid norm 2.157687745805e+04 true resid norm 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.949268476386e+02 true resid norm 1.243419788627e+02 ||r(i)||/||b|| 3.907665598415e-02 2 KSP preconditioned resid norm 5.078054475792e+00 true resid norm 2.745355604400e+00 ||r(i)||/||b|| 8.627763325675e-04 3 KSP preconditioned resid norm 8.663802743529e-02 true resid norm 4.254290979292e-02 ||r(i)||/||b|| 1.336985839979e-05 4 KSP preconditioned resid norm 1.795605563039e-03 true resid norm 9.040507428245e-04 ||r(i)||/||b|| 2.841138623714e-07 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 -pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual 0 KSP preconditioned resid norm 1.825767020538e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 6.495628259383e-04 true resid norm 3.739440526742e-04 ||r(i)||/||b|| 1.254902367550e-01 2 KSP preconditioned resid norm 4.971875712015e-05 true resid norm 2.118856024328e-05 ||r(i)||/||b|| 7.110575559127e-03 3 KSP preconditioned resid norm 3.726806462912e-06 true resid norm 1.370355844514e-06 ||r(i)||/||b|| 4.598716790303e-04 4 KSP preconditioned resid norm 2.496898447120e-07 true resid norm 9.494701893753e-08 ||r(i)||/||b|| 3.186285167645e-05 5 KSP preconditioned resid norm 1.541814409235e-08 true resid norm 6.216753346769e-09 ||r(i)||/||b|| 2.086252859898e-06 6 KSP preconditioned resid norm 1.153890845138e-09 true resid norm 5.290239857745e-10 ||r(i)||/||b|| 1.775328281039e-07 0 KSP preconditioned resid norm 1.961448048639e+04 true resid norm 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 7.940694187370e+02 true resid norm 4.331011797078e+02 ||r(i)||/||b|| 1.361096707691e-01 2 KSP preconditioned resid norm 6.141876183555e+01 true resid norm 2.734346095946e+01 ||r(i)||/||b|| 8.593164007057e-03 3 KSP preconditioned resid norm 4.872887149917e+00 true resid norm 1.774255242955e+00 ||r(i)||/||b|| 5.575909470898e-04 4 KSP preconditioned resid norm 3.088357668927e-01 true resid norm 1.183728642343e-01 ||r(i)||/||b|| 3.720075662179e-05 5 KSP preconditioned resid norm 2.030016543073e-02 true resid norm 7.924623904393e-03 ||r(i)||/||b|| 2.490452580442e-06 6 KSP preconditioned resid norm 1.458276941086e-03 true resid norm 6.781128809522e-04 ||r(i)||/||b|| 2.131089114856e-07 0 KSP preconditioned resid norm 6.230592591466e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.825349376322e+01 true resid norm 7.755266613308e+02 ||r(i)||/||b|| 4.126287287931e+00 2 KSP preconditioned resid norm 4.321561767174e+00 true resid norm 2.170558998883e+02 ||r(i)||/||b|| 1.154873255992e+00 3 KSP preconditioned resid norm 2.806349660119e-01 true resid norm 2.931496742303e+01 ||r(i)||/||b|| 1.559739767247e-01 4 KSP preconditioned resid norm 1.707567397460e-02 true resid norm 2.684913551118e+00 ||r(i)||/||b|| 1.428542074383e-02 5 KSP preconditioned resid norm 1.741069717192e-03 true resid norm 2.914639372698e-01 ||r(i)||/||b|| 1.550770591410e-03 6 KSP preconditioned resid norm 1.460913620440e-04 true resid norm 3.460791330512e-02 ||r(i)||/||b|| 1.841357619965e-04 7 KSP preconditioned resid norm 1.741167177387e-05 true resid norm 3.396573365236e-03 ||r(i)||/||b|| 1.807189642642e-05 -pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 -ksp_max_it 30 -ksp_monitor_true_residual 0 KSP preconditioned resid norm 1.244808265687e+15 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.064535247522e+14 true resid norm 2.984544079484e-03 ||r(i)||/||b|| 1.001569995463e+00 2 KSP preconditioned resid norm 5.618140421534e+12 true resid norm 2.985603691163e-03 ||r(i)||/||b|| 1.001925585876e+00 3 KSP preconditioned resid norm 1.553607230691e+12 true resid norm 2.986068066312e-03 ||r(i)||/||b|| 1.002081423486e+00 4 KSP preconditioned resid norm 2.754119595329e+11 true resid norm 2.986119711375e-03 ||r(i)||/||b|| 1.002098754825e+00 5 KSP preconditioned resid norm 2.443949058171e+11 true resid norm 2.986120048522e-03 ||r(i)||/||b|| 1.002098867967e+00 6 KSP preconditioned resid norm 5.097094561118e+10 true resid norm 2.986121310105e-03 ||r(i)||/||b|| 1.002099291336e+00 7 KSP preconditioned resid norm 5.917979151193e+09 true resid norm 2.986121369446e-03 ||r(i)||/||b|| 1.002099311250e+00 8 KSP preconditioned resid norm 5.917672183458e+09 true resid norm 2.986121369424e-03 ||r(i)||/||b|| 1.002099311243e+00 9 KSP preconditioned resid norm 4.641300731865e+08 true resid norm 2.986121370475e-03 ||r(i)||/||b|| 1.002099311595e+00 10 KSP preconditioned resid norm 4.634203577645e+08 true resid norm 2.986121382852e-03 ||r(i)||/||b|| 1.002099315749e+00 11 KSP preconditioned resid norm 4.587254969048e+08 true resid norm 2.986121419848e-03 ||r(i)||/||b|| 1.002099328164e+00 12 KSP preconditioned resid norm 4.586269695339e+08 true resid norm 2.986121536662e-03 ||r(i)||/||b|| 1.002099367365e+00 13 KSP preconditioned resid norm 4.581015928356e+08 true resid norm 2.986122475198e-03 ||r(i)||/||b|| 1.002099682325e+00 14 KSP preconditioned resid norm 4.571106094607e+08 true resid norm 2.986124378604e-03 ||r(i)||/||b|| 1.002100321080e+00 15 KSP preconditioned resid norm 4.536929046842e+08 true resid norm 2.986134395719e-03 ||r(i)||/||b|| 1.002103682680e+00 16 KSP preconditioned resid norm 4.535016059345e+08 true resid norm 2.986135027367e-03 ||r(i)||/||b|| 1.002103894652e+00 17 KSP preconditioned resid norm 4.534978476038e+08 true resid norm 2.986135001016e-03 ||r(i)||/||b|| 1.002103885808e+00 18 KSP preconditioned resid norm 4.467301680293e+08 true resid norm 2.986152055223e-03 ||r(i)||/||b|| 1.002109608955e+00 19 KSP preconditioned resid norm 4.310227073192e+08 true resid norm 2.986506137056e-03 ||r(i)||/||b|| 1.002228433717e+00 20 KSP preconditioned resid norm 3.520200847767e+08 true resid norm 2.989053346159e-03 ||r(i)||/||b|| 1.003083240395e+00 21 KSP preconditioned resid norm 3.273563895836e+08 true resid norm 2.990009521982e-03 ||r(i)||/||b|| 1.003404119226e+00 22 KSP preconditioned resid norm 1.692012480634e+08 true resid norm 2.999909265923e-03 ||r(i)||/||b|| 1.006726330669e+00 23 KSP preconditioned resid norm 1.616841528495e+08 true resid norm 3.002594301034e-03 ||r(i)||/||b|| 1.007627389770e+00 24 KSP preconditioned resid norm 1.588031462511e+08 true resid norm 3.003789395992e-03 ||r(i)||/||b|| 1.008028446420e+00 25 KSP preconditioned resid norm 1.585650863283e+08 true resid norm 3.003987247746e-03 ||r(i)||/||b|| 1.008094842618e+00 26 KSP preconditioned resid norm 1.482994894928e+08 true resid norm 3.004024810257e-03 ||r(i)||/||b|| 1.008107448056e+00 27 KSP preconditioned resid norm 1.293588493466e+08 true resid norm 3.005576275194e-03 ||r(i)||/||b|| 1.008628097337e+00 28 KSP preconditioned resid norm 1.082178475680e+08 true resid norm 3.010519288328e-03 ||r(i)||/||b|| 1.010286901332e+00 0 KSP preconditioned resid norm 4.688654651573e+20 true resid norm 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 4.673814485341e+20 true resid norm 3.182057223735e+03 ||r(i)||/||b|| 1.000017504878e+00 2 KSP preconditioned resid norm 1.203925723825e+19 true resid norm 3.185040065807e+03 ||r(i)||/||b|| 1.000954915514e+00 3 KSP preconditioned resid norm 3.042270671882e+18 true resid norm 3.187076078024e+03 ||r(i)||/||b|| 1.001594768198e+00 4 KSP preconditioned resid norm 5.678481873896e+17 true resid norm 3.187261697361e+03 ||r(i)||/||b|| 1.001653102343e+00 5 KSP preconditioned resid norm 4.462228267454e+17 true resid norm 3.187264158420e+03 ||r(i)||/||b|| 1.001653875774e+00 6 KSP preconditioned resid norm 9.314909592131e+16 true resid norm 3.187268102332e+03 ||r(i)||/||b|| 1.001655115218e+00 7 KSP preconditioned resid norm 8.843621410196e+15 true resid norm 3.187268285359e+03 ||r(i)||/||b|| 1.001655172737e+00 8 KSP preconditioned resid norm 8.214565462317e+15 true resid norm 3.187268286281e+03 ||r(i)||/||b|| 1.001655173027e+00 9 KSP preconditioned resid norm 4.525549868436e+14 true resid norm 3.187268287235e+03 ||r(i)||/||b|| 1.001655173327e+00 10 KSP preconditioned resid norm 4.522301211733e+14 true resid norm 3.187268289937e+03 ||r(i)||/||b|| 1.001655174176e+00 11 KSP preconditioned resid norm 4.295952793336e+14 true resid norm 3.187268328860e+03 ||r(i)||/||b|| 1.001655186408e+00 12 KSP preconditioned resid norm 4.294637249487e+14 true resid norm 3.187268422725e+03 ||r(i)||/||b|| 1.001655215907e+00 13 KSP preconditioned resid norm 4.285778654372e+14 true resid norm 3.187269536466e+03 ||r(i)||/||b|| 1.001655565920e+00 14 KSP preconditioned resid norm 4.162983479677e+14 true resid norm 3.187285280554e+03 ||r(i)||/||b|| 1.001660513777e+00 15 KSP preconditioned resid norm 4.162978556133e+14 true resid norm 3.187285288668e+03 ||r(i)||/||b|| 1.001660516326e+00 16 KSP preconditioned resid norm 4.161875124570e+14 true resid norm 3.187285309889e+03 ||r(i)||/||b|| 1.001660522996e+00 17 KSP preconditioned resid norm 4.117671313790e+14 true resid norm 3.187289951588e+03 ||r(i)||/||b|| 1.001661981731e+00 18 KSP preconditioned resid norm 4.103112320458e+14 true resid norm 3.187292327095e+03 ||r(i)||/||b|| 1.001662728276e+00 19 KSP preconditioned resid norm 4.032611123108e+14 true resid norm 3.187463967167e+03 ||r(i)||/||b|| 1.001716669191e+00 20 KSP preconditioned resid norm 3.432105733172e+14 true resid norm 3.189686334937e+03 ||r(i)||/||b|| 1.002415087389e+00 21 KSP preconditioned resid norm 3.125440416815e+14 true resid norm 3.191137543657e+03 ||r(i)||/||b|| 1.002871155278e+00 22 KSP preconditioned resid norm 2.214281952780e+14 true resid norm 3.198766855775e+03 ||r(i)||/||b|| 1.005268800931e+00 23 KSP preconditioned resid norm 2.205574806871e+14 true resid norm 3.198012835064e+03 ||r(i)||/||b|| 1.005031836647e+00 24 KSP preconditioned resid norm 2.202202974538e+14 true resid norm 3.197792157500e+03 ||r(i)||/||b|| 1.004962484838e+00 25 KSP preconditioned resid norm 2.188941573096e+14 true resid norm 3.197631986560e+03 ||r(i)||/||b|| 1.004912148300e+00 26 KSP preconditioned resid norm 1.811445509155e+14 true resid norm 3.201511171410e+03 ||r(i)||/||b|| 1.006131250435e+00 27 KSP preconditioned resid norm 1.333006235872e+14 true resid norm 3.207865456494e+03 ||r(i)||/||b|| 1.008128196394e+00 28 KSP preconditioned resid norm 1.290269724722e+14 true resid norm 3.209026547700e+03 ||r(i)||/||b|| 1.008493089747e+00 29 KSP preconditioned resid norm 8.645848930695e+13 true resid norm 3.216715733004e+03 ||r(i)||/||b|| 1.010909551603e+00 30 KSP preconditioned resid norm 7.051095175336e+13 true resid norm 3.219405322929e+03 ||r(i)||/||b|| 1.011754802589e+00 0 KSP preconditioned resid norm 4.970534641714e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 9.825390294838e+01 true resid norm 6.304087699909e+03 ||r(i)||/||b|| 3.354169267824e+01 2 KSP preconditioned resid norm 1.317425630977e+01 true resid norm 1.659038483292e+03 ||r(i)||/||b|| 8.827123224947e+00 3 KSP preconditioned resid norm 1.267331175258e+00 true resid norm 3.723773819327e+02 ||r(i)||/||b|| 1.981280765700e+00 4 KSP preconditioned resid norm 1.451198865319e-01 true resid norm 6.113281457366e+01 ||r(i)||/||b|| 3.252648403059e-01 5 KSP preconditioned resid norm 2.428012832580e-02 true resid norm 9.525516489005e+00 ||r(i)||/||b|| 5.068171032587e-02 6 KSP preconditioned resid norm 3.273131599046e-03 true resid norm 1.693121214500e+00 ||r(i)||/||b|| 9.008464689439e-03 7 KSP preconditioned resid norm 3.629020564958e-04 true resid norm 1.937921370699e-01 ||r(i)||/||b|| 1.031095475584e-03 8 KSP preconditioned resid norm 4.303742583350e-05 true resid norm 2.733022203972e-02 ||r(i)||/||b|| 1.454138889117e-04 -pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true -pc_gamg_square_graph 20 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 -ksp_max_it 30 -ksp_monitor_true_residual 0 KSP preconditioned resid norm 3.031864566839e+14 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.212883161649e+14 true resid norm 2.982229202367e-03 ||r(i)||/||b|| 1.000793156052e+00 2 KSP preconditioned resid norm 5.312941731712e+12 true resid norm 2.985627671175e-03 ||r(i)||/||b|| 1.001933633223e+00 3 KSP preconditioned resid norm 3.602406845592e+12 true resid norm 2.985818915765e-03 ||r(i)||/||b|| 1.001997812152e+00 4 KSP preconditioned resid norm 6.891073564923e+10 true resid norm 2.986120881484e-03 ||r(i)||/||b|| 1.002099147497e+00 5 KSP preconditioned resid norm 1.267096776171e+09 true resid norm 2.986121018547e-03 ||r(i)||/||b|| 1.002099193494e+00 6 KSP preconditioned resid norm 5.130735430694e+08 true resid norm 2.986121020564e-03 ||r(i)||/||b|| 1.002099194170e+00 7 KSP preconditioned resid norm 5.122457469991e+08 true resid norm 2.986121025937e-03 ||r(i)||/||b|| 1.002099195974e+00 8 KSP preconditioned resid norm 5.115042446514e+08 true resid norm 2.986121044146e-03 ||r(i)||/||b|| 1.002099202084e+00 9 KSP preconditioned resid norm 5.103842476065e+08 true resid norm 2.986121084005e-03 ||r(i)||/||b|| 1.002099215460e+00 10 KSP preconditioned resid norm 5.103414725629e+08 true resid norm 2.986121151167e-03 ||r(i)||/||b|| 1.002099237999e+00 11 KSP preconditioned resid norm 5.103050707318e+08 true resid norm 2.986121488999e-03 ||r(i)||/||b|| 1.002099351370e+00 12 KSP preconditioned resid norm 5.101511376685e+08 true resid norm 2.986123179301e-03 ||r(i)||/||b|| 1.002099918611e+00 13 KSP preconditioned resid norm 5.101218154297e+08 true resid norm 2.986123839891e-03 ||r(i)||/||b|| 1.002100140296e+00 14 KSP preconditioned resid norm 5.095285470767e+08 true resid norm 2.986138347067e-03 ||r(i)||/||b|| 1.002105008695e+00 15 KSP preconditioned resid norm 5.082373114330e+08 true resid norm 2.986170368742e-03 ||r(i)||/||b|| 1.002115754708e+00 16 KSP preconditioned resid norm 5.079055966450e+08 true resid norm 2.986178765357e-03 ||r(i)||/||b|| 1.002118572491e+00 17 KSP preconditioned resid norm 4.278159855635e+08 true resid norm 2.989173921061e-03 ||r(i)||/||b|| 1.003123703595e+00 18 KSP preconditioned resid norm 3.704767561598e+08 true resid norm 2.991993992919e-03 ||r(i)||/||b|| 1.004070079082e+00 19 KSP preconditioned resid norm 3.690160215681e+08 true resid norm 2.992090282533e-03 ||r(i)||/||b|| 1.004102392489e+00 20 KSP preconditioned resid norm 3.135406273863e+08 true resid norm 2.996344554486e-03 ||r(i)||/||b|| 1.005530064867e+00 21 KSP preconditioned resid norm 1.938459923255e+08 true resid norm 3.005844334042e-03 ||r(i)||/||b|| 1.008718054025e+00 22 KSP preconditioned resid norm 1.827826394560e+08 true resid norm 3.007605246670e-03 ||r(i)||/||b|| 1.009308990933e+00 23 KSP preconditioned resid norm 1.108660460314e+08 true resid norm 3.020965814060e-03 ||r(i)||/||b|| 1.013792604867e+00 24 KSP preconditioned resid norm 1.051235646374e+08 true resid norm 3.021541389078e-03 ||r(i)||/||b|| 1.013985759551e+00 25 KSP preconditioned resid norm 7.173044522784e+07 true resid norm 3.024254088703e-03 ||r(i)||/||b|| 1.014896102464e+00 26 KSP preconditioned resid norm 6.350860057272e+07 true resid norm 3.023434854983e-03 ||r(i)||/||b|| 1.014621179430e+00 27 KSP preconditioned resid norm 5.267152287984e+07 true resid norm 3.022203752421e-03 ||r(i)||/||b|| 1.014208039146e+00 28 KSP preconditioned resid norm 4.650599761568e+07 true resid norm 3.022093139351e-03 ||r(i)||/||b|| 1.014170918994e+00 29 KSP preconditioned resid norm 3.141941642480e+07 true resid norm 3.023444082486e-03 ||r(i)||/||b|| 1.014624276047e+00 30 KSP preconditioned resid norm 2.065598123858e+07 true resid norm 3.024498453617e-03 ||r(i)||/||b|| 1.014978107808e+00 0 KSP preconditioned resid norm 4.257133849062e+20 true resid norm 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.793742274994e+19 true resid norm 3.184922256681e+03 ||r(i)||/||b|| 1.000917891922e+00 2 KSP preconditioned resid norm 1.137325629643e+19 true resid norm 3.185147137826e+03 ||r(i)||/||b|| 1.000988564781e+00 3 KSP preconditioned resid norm 7.164960007703e+18 true resid norm 3.186117509159e+03 ||r(i)||/||b|| 1.001293521056e+00 4 KSP preconditioned resid norm 1.109461464210e+17 true resid norm 3.187268097356e+03 ||r(i)||/||b|| 1.001655113654e+00 5 KSP preconditioned resid norm 1.984768045830e+15 true resid norm 3.187268427639e+03 ||r(i)||/||b|| 1.001655217451e+00 6 KSP preconditioned resid norm 7.354105789290e+14 true resid norm 3.187268429720e+03 ||r(i)||/||b|| 1.001655218105e+00 7 KSP preconditioned resid norm 6.662738391887e+14 true resid norm 3.187268442496e+03 ||r(i)||/||b|| 1.001655222120e+00 8 KSP preconditioned resid norm 5.358556594776e+14 true resid norm 3.187268479547e+03 ||r(i)||/||b|| 1.001655233764e+00 9 KSP preconditioned resid norm 5.055368509046e+14 true resid norm 3.187268491131e+03 ||r(i)||/||b|| 1.001655237405e+00 10 KSP preconditioned resid norm 5.050370080533e+14 true resid norm 3.187268557074e+03 ||r(i)||/||b|| 1.001655258129e+00 11 KSP preconditioned resid norm 5.049526065770e+14 true resid norm 3.187269209319e+03 ||r(i)||/||b|| 1.001655463108e+00 12 KSP preconditioned resid norm 5.048442087580e+14 true resid norm 3.187270145328e+03 ||r(i)||/||b|| 1.001655757265e+00 13 KSP preconditioned resid norm 5.048317293084e+14 true resid norm 3.187270420057e+03 ||r(i)||/||b|| 1.001655843604e+00 14 KSP preconditioned resid norm 5.046339848740e+14 true resid norm 3.187276012517e+03 ||r(i)||/||b|| 1.001657601133e+00 15 KSP preconditioned resid norm 5.036574780195e+14 true resid norm 3.187304228896e+03 ||r(i)||/||b|| 1.001666468627e+00 16 KSP preconditioned resid norm 5.033948448037e+14 true resid norm 3.187311929535e+03 ||r(i)||/||b|| 1.001668888688e+00 17 KSP preconditioned resid norm 4.374073117273e+14 true resid norm 3.190248474209e+03 ||r(i)||/||b|| 1.002591749552e+00 18 KSP preconditioned resid norm 3.454318321770e+14 true resid norm 3.195991944291e+03 ||r(i)||/||b|| 1.004396736143e+00 19 KSP preconditioned resid norm 3.438483821871e+14 true resid norm 3.196113376292e+03 ||r(i)||/||b|| 1.004434898287e+00 20 KSP preconditioned resid norm 3.090011643835e+14 true resid norm 3.199125186774e+03 ||r(i)||/||b|| 1.005381412756e+00 21 KSP preconditioned resid norm 1.976112359751e+14 true resid norm 3.209202875553e+03 ||r(i)||/||b|| 1.008548503879e+00 22 KSP preconditioned resid norm 1.874048396302e+14 true resid norm 3.210733816807e+03 ||r(i)||/||b|| 1.009029629122e+00 23 KSP preconditioned resid norm 1.086663247242e+14 true resid norm 3.224219602770e+03 ||r(i)||/||b|| 1.013267774787e+00 24 KSP preconditioned resid norm 1.036005882413e+14 true resid norm 3.224749127723e+03 ||r(i)||/||b|| 1.013434187326e+00 25 KSP preconditioned resid norm 6.943244220256e+13 true resid norm 3.227732423395e+03 ||r(i)||/||b|| 1.014371740514e+00 26 KSP preconditioned resid norm 6.064453821356e+13 true resid norm 3.227303114420e+03 ||r(i)||/||b|| 1.014236822611e+00 27 KSP preconditioned resid norm 5.237876331038e+13 true resid norm 3.226320811775e+03 ||r(i)||/||b|| 1.013928116710e+00 28 KSP preconditioned resid norm 4.407157490353e+13 true resid norm 3.226123552298e+03 ||r(i)||/||b|| 1.013866124447e+00 29 KSP preconditioned resid norm 3.691867703712e+13 true resid norm 3.226578266524e+03 ||r(i)||/||b|| 1.014009026398e+00 0 KSP preconditioned resid norm 4.105203293801e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.404700393158e+02 true resid norm 5.941722233814e+03 ||r(i)||/||b|| 3.161368157187e+01 2 KSP preconditioned resid norm 3.849004101235e+01 true resid norm 3.456178528017e+03 ||r(i)||/||b|| 1.838903320294e+01 3 KSP preconditioned resid norm 8.384263059954e+00 true resid norm 1.401839902990e+03 ||r(i)||/||b|| 7.458665781386e+00 4 KSP preconditioned resid norm 1.363029002549e+00 true resid norm 3.612540200618e+02 ||r(i)||/||b|| 1.922097517753e+00 5 KSP preconditioned resid norm 3.734525206097e-01 true resid norm 1.272038960182e+02 ||r(i)||/||b|| 6.768043515285e-01 6 KSP preconditioned resid norm 8.146021124788e-02 true resid norm 3.196642795661e+01 ||r(i)||/||b|| 1.700814064749e-01 7 KSP preconditioned resid norm 2.110568459516e-02 true resid norm 6.793208791728e+00 ||r(i)||/||b|| 3.614412305757e-02 8 KSP preconditioned resid norm 4.044708317961e-03 true resid norm 1.976363197299e+00 ||r(i)||/||b|| 1.051548933644e-02 9 KSP preconditioned resid norm 9.154675861687e-04 true resid norm 3.458820713849e-01 ||r(i)||/||b|| 1.840309128547e-03 10 KSP preconditioned resid norm 2.106487039520e-04 true resid norm 1.064965566696e-01 ||r(i)||/||b|| 5.666283442018e-04 11 KSP preconditioned resid norm 5.145654020522e-05 true resid norm 2.436255895394e-02 ||r(i)||/||b|| 1.296240636532e-04 12 KSP preconditioned resid norm 1.223910887488e-05 true resid norm 4.954689842368e-03 ||r(i)||/||b|| 2.636205140533e-05 > Il giorno 01 ago 2018, alle ore 15:41, Matthew Knepley ha scritto: > > On Wed, Aug 1, 2018 at 9:02 AM Pierpaolo Minelli > wrote: >> Il giorno 27 lug 2018, alle ore 18:32, Smith, Barry F. > ha scritto: >> >>> On Jul 27, 2018, at 3:26 AM, Pierpaolo Minelli > wrote: >>> >>> >>> Finally, I have a question. In my simulation I solve the two systems at each step of the calculation, and it was my habit to use the following option after the first resolution and before solving the system in the second time step: >>> >>> call KSPSetInitialGuessNonzero(ksp,PETSC_TRUE,ierr) >>> >>> Since this option was incompatible with the use of MUMPS or SuperLU_Dist, I commented on it and noticed, to my surprise, that iterative methods were not affected by this comment, rather they were slightly faster. Is this normal? Or do I use this command incorrectly? >> >> Presuming this is a linear problem? >> >> You should run with -ksp_monitor_true_residual and compare the final residual norms (at linear system convergence). Since KSP uses a relative decrease in the residual norm to declare convergence what you have told us isn't enough to determine if one is converging "faster" to the solution then the other. >> >> Barry > > Yes, there are two linear problems. The first in the field of complex numbers (which I divided into two problems in the field of real numbers as suggested by Matthew) and the second in the field of real numbers. > > These are the results obtained using the option -ksp_monitor_true_residual: > > -pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 -ksp_monitor_true_residual > > 0 KSP preconditioned resid norm 1.324344286254e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.399266083153e-03 true resid norm 1.196951495628e+05 ||r(i)||/||b|| 4.016796777391e+07 > 2 KSP preconditioned resid norm 6.287919852336e-04 true resid norm 4.429876706490e+04 ||r(i)||/||b|| 1.486602802524e+07 > 3 KSP preconditioned resid norm 8.836547690039e-05 true resid norm 1.182383826632e+04 ||r(i)||/||b|| 3.967909778970e+06 > 4 KSP preconditioned resid norm 1.291370058561e-05 true resid norm 2.801893692950e+03 ||r(i)||/||b|| 9.402751571421e+05 > 5 KSP preconditioned resid norm 2.073922228951e-06 true resid norm 6.312112895919e+02 ||r(i)||/||b|| 2.118254150770e+05 > 6 KSP preconditioned resid norm 3.283811876800e-07 true resid norm 8.777865833701e+01 ||r(i)||/||b|| 2.945725313178e+04 > 7 KSP preconditioned resid norm 5.414680273500e-08 true resid norm 1.610127004050e+01 ||r(i)||/||b|| 5.403354258448e+03 > 8 KSP preconditioned resid norm 9.645834363683e-09 true resid norm 3.006444251909e+00 ||r(i)||/||b|| 1.008919377818e+03 > 9 KSP preconditioned resid norm 1.915420455785e-09 true resid norm 6.672996533262e-01 ||r(i)||/||b|| 2.239361500298e+02 > 10 KSP preconditioned resid norm 3.334928638696e-10 true resid norm 1.185976397497e-01 ||r(i)||/||b|| 3.979965929219e+01 > > You can see from the "true resid norm" that your complex problem is not actually being solved. ML and Hypre have similar results. > I would guess that your coarse grid is near singular. > > The real problem is being solved correctly, although you are still 100x off the true residual so the preconditioner is not great. > Have you tested with a manufactured solution? > > Thanks, > > Matt > > 0 KSP preconditioned resid norm 1.416256896904e+04 true resid norm 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.781264980774e+03 true resid norm 1.283809201228e+11 ||r(i)||/||b|| 1.938227104995e+05 > 2 KSP preconditioned resid norm 7.392413714593e+02 true resid norm 4.990467508600e+10 ||r(i)||/||b|| 7.534343407504e+04 > 3 KSP preconditioned resid norm 1.087641767696e+02 true resid norm 1.367263690390e+10 ||r(i)||/||b|| 2.064222270610e+04 > 4 KSP preconditioned resid norm 1.627726591174e+01 true resid norm 3.451534923895e+09 ||r(i)||/||b|| 5.210944536719e+03 > 5 KSP preconditioned resid norm 2.564636460142e+00 true resid norm 7.980525032990e+08 ||r(i)||/||b|| 1.204857381941e+03 > 6 KSP preconditioned resid norm 4.252626820180e-01 true resid norm 1.151817528111e+08 ||r(i)||/||b|| 1.738953070953e+02 > 7 KSP preconditioned resid norm 6.758292325957e-02 true resid norm 2.065701091779e+07 ||r(i)||/||b|| 3.118686050134e+01 > 8 KSP preconditioned resid norm 1.099617201063e-02 true resid norm 3.470561062696e+06 ||r(i)||/||b|| 5.239669192917e+00 > 9 KSP preconditioned resid norm 2.195352537111e-03 true resid norm 7.056823048483e+05 ||r(i)||/||b|| 1.065401750871e+00 > 10 KSP preconditioned resid norm 4.380752631896e-04 true resid norm 1.440377395627e+05 ||r(i)||/||b|| 2.174605468598e-01 > > 0 KSP preconditioned resid norm 4.970534641714e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 9.825390294838e+01 true resid norm 6.304087699909e+03 ||r(i)||/||b|| 3.354169267824e+01 > 2 KSP preconditioned resid norm 1.317425630977e+01 true resid norm 1.659038483292e+03 ||r(i)||/||b|| 8.827123224947e+00 > 3 KSP preconditioned resid norm 1.267331175258e+00 true resid norm 3.723773819327e+02 ||r(i)||/||b|| 1.981280765700e+00 > 4 KSP preconditioned resid norm 1.451198865319e-01 true resid norm 6.113281457366e+01 ||r(i)||/||b|| 3.252648403059e-01 > 5 KSP preconditioned resid norm 2.428012832580e-02 true resid norm 9.525516489005e+00 ||r(i)||/||b|| 5.068171032587e-02 > 6 KSP preconditioned resid norm 3.273131599046e-03 true resid norm 1.693121214500e+00 ||r(i)||/||b|| 9.008464689439e-03 > 7 KSP preconditioned resid norm 3.629020564958e-04 true resid norm 1.937921370699e-01 ||r(i)||/||b|| 1.031095475584e-03 > 8 KSP preconditioned resid norm 4.303742583350e-05 true resid norm 2.733022203972e-02 ||r(i)||/||b|| 1.454138889117e-04 > > -pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual > > 0 KSP preconditioned resid norm 1.825767020537e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 6.495628259378e-04 true resid norm 1.373525306349e+04 ||r(i)||/||b|| 4.609353047603e+06 > 2 KSP preconditioned resid norm 4.971875712010e-05 true resid norm 2.154150315236e+03 ||r(i)||/||b|| 7.229018114651e+05 > 3 KSP preconditioned resid norm 3.726806462903e-06 true resid norm 3.000693510070e+02 ||r(i)||/||b|| 1.006989511706e+05 > 4 KSP preconditioned resid norm 2.496898447113e-07 true resid norm 3.004338446358e+01 ||r(i)||/||b|| 1.008212699813e+04 > 5 KSP preconditioned resid norm 1.541814409235e-08 true resid norm 2.256927674575e+00 ||r(i)||/||b|| 7.573924125705e+02 > 6 KSP preconditioned resid norm 1.153890845088e-09 true resid norm 2.007294077611e-01 ||r(i)||/||b|| 6.736189738408e+01 > 0 KSP preconditioned resid norm 1.961448048638e+04 true resid norm 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.940694187362e+02 true resid norm 1.483756468402e+10 ||r(i)||/||b|| 2.240096894085e+04 > 2 KSP preconditioned resid norm 6.141876183549e+01 true resid norm 2.581042149104e+09 ||r(i)||/||b|| 3.896720671376e+03 > 3 KSP preconditioned resid norm 4.872887149903e+00 true resid norm 3.544664743366e+08 ||r(i)||/||b|| 5.351547003355e+02 > 4 KSP preconditioned resid norm 3.088357668912e-01 true resid norm 3.689655474675e+07 ||r(i)||/||b|| 5.570446326655e+01 > 5 KSP preconditioned resid norm 2.030016543101e-02 true resid norm 2.847019997470e+06 ||r(i)||/||b|| 4.298279933093e+00 > 6 KSP preconditioned resid norm 1.458276940703e-03 true resid norm 2.567051860886e+05 ||r(i)||/||b|| 3.875598875547e-01 > > 0 KSP preconditioned resid norm 6.230592591466e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.825349376322e+01 true resid norm 7.755266613308e+02 ||r(i)||/||b|| 4.126287287931e+00 > 2 KSP preconditioned resid norm 4.321561767174e+00 true resid norm 2.170558998883e+02 ||r(i)||/||b|| 1.154873255992e+00 > 3 KSP preconditioned resid norm 2.806349660119e-01 true resid norm 2.931496742303e+01 ||r(i)||/||b|| 1.559739767247e-01 > 4 KSP preconditioned resid norm 1.707567397460e-02 true resid norm 2.684913551118e+00 ||r(i)||/||b|| 1.428542074383e-02 > 5 KSP preconditioned resid norm 1.741069717192e-03 true resid norm 2.914639372698e-01 ||r(i)||/||b|| 1.550770591410e-03 > 6 KSP preconditioned resid norm 1.460913620440e-04 true resid norm 3.460791330512e-02 ||r(i)||/||b|| 1.841357619965e-04 > 7 KSP preconditioned resid norm 1.741167177387e-05 true resid norm 3.396573365236e-03 ||r(i)||/||b|| 1.807189642642e-05 > > -pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual > > 0 KSP preconditioned resid norm 1.984853668903e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.924446712660e-04 true resid norm 8.461145171168e+03 ||r(i)||/||b|| 2.839438421750e+06 > 2 KSP preconditioned resid norm 5.161509100761e-06 true resid norm 4.501007519328e+02 ||r(i)||/||b|| 1.510473278548e+05 > 3 KSP preconditioned resid norm 9.297326931235e-08 true resid norm 1.474595580807e+01 ||r(i)||/||b|| 4.948530327732e+03 > 4 KSP preconditioned resid norm 1.910271882618e-09 true resid norm 3.603243780988e-01 ||r(i)||/||b|| 1.209196701829e+02 > 0 KSP preconditioned resid norm 2.157687745804e+04 true resid norm 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.949268476385e+02 true resid norm 8.974916757495e+09 ||r(i)||/||b|| 1.354985375382e+04 > 2 KSP preconditioned resid norm 5.078054475786e+00 true resid norm 4.502684440161e+08 ||r(i)||/||b|| 6.797914377626e+02 > 3 KSP preconditioned resid norm 8.663802743525e-02 true resid norm 1.432117031381e+07 ||r(i)||/||b|| 2.162134408362e+01 > 4 KSP preconditioned resid norm 1.795605563041e-03 true resid norm 3.389868548833e+05 ||r(i)||/||b|| 5.117843911255e-01 > > 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 > 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 > 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 > 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 > 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 > > Thanks > > Pierpaolo > >>> >>> Thanks >>> >>> Pierpaolo >>> >>>> Il giorno 23 lug 2018, alle ore 15:43, Mark Adams > ha scritto: >>>> >>>> Note, as Barry said, GAMG works with native complex numbers. You can start with your original complex build and use '-pc_type gamg'. >>>> Mark >>>> >>>> On Mon, Jul 23, 2018 at 6:52 AM Pierpaolo Minelli > wrote: >>>> >>>> >>>>> Il giorno 20 lug 2018, alle ore 19:58, Smith, Barry F. > ha scritto: >>>>> >>>>> >>>>> >>>>>> On Jul 20, 2018, at 7:01 AM, Pierpaolo Minelli > wrote: >>>>>> >>>>>> Hi, >>>>>> >>>>>> in my code I have to solve both a system in the field of real numbers and in the field of complex numbers. >>>>>> My approach has been as follows. >>>>>> First I configured PETSc with the --with-scalar-type=complex option. >>>>>> Using this option I have unfortunately lost the possibility to use the two preconditioners ML and Hypre. >>>>> >>>>> You should still be able to use the PETSc PCGAMG algebraic multigrid solver. Have you tried that? If there are issues let us know because we would like to continue to improve the performance of PCGAMG to get it to be closer to as good as ML and hypre. >>>>> >>>>> Barry >>>>> >>>> >>>> I will try to convert, as suggested by Matthew, my complex system in a system twice as large in real numbers. When i finish, i will try to use ML, Hypre and GAMG and i let you know if there are any performance differences. >>>> >>>> Thanks >>>> >>>> Pierpaolo >>>> >>>> >>>>>> I later created two subspaces of Krylov and tried to solve the two systems as I used to when solving the only equation in the real numbers field. >>>>>> In order to correctly solve the system in the field of real numbers I had to transform the coefficients from real to complex with an imaginary part equal to zero. >>>>>> >>>>>> Is there a possibility to use a different and better approach to solve my problem? >>>>>> >>>>>> Perhaps an approach where you can continue to use ML and Hypre for system solving in the real numbers field or where you don't need to use complex numbers when real numbers would actually suffice? >>>>>> >>>>>> Thanks in advance >>>>>> >>>>>> Pierpaolo >>>>>> >>>>> >>>> >>> >> > > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From david97sommer at gmail.com Thu Aug 2 06:00:22 2018 From: david97sommer at gmail.com (David Sommer) Date: Thu, 2 Aug 2018 13:00:22 +0200 Subject: [petsc-users] Parallel QR decomposition In-Reply-To: References: Message-ID: Hi, sorry i haven't answered in a while. >> i was wondering if there is an implementation of parallel qr decomposition in PETSc. > For what purpose do you need a QR? We may have suggestions if we know how you want to use it. I found an interesting algorithm for radial basis function interpolation. It mitigates the ill-conditioning that arises from making radial basis functions increasingly flat. The paper can be found at https://amath.colorado.edu/faculty/fornberg/Docs/SISCmanuscript.pdf The algorithm defines a Matrix C that is rectangular (more columns than rows). Then a QR Decomposition of C is computed. It looks like this: C = Q [R1 R2] with R1 being rectangular and R2 being stacked on it horizontally. What i want to compute in the end is: R_1^{-1} R_2 Which isn't that hard to compute once R is known, as this is just backward substitution. Anyway i still need to do a full QR decomposition (Even though i don't actually need Q, it would be easy to calculate from R, so i don't think there is any shortcut to Q, except that i don't have to store Q). What i was thinking of as a possible solution is to parallelize Givens rotations by leveraging the fact that it only has local row-wise data dependencies in each step. Best regards David Sommer -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Thu Aug 2 10:39:01 2018 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 2 Aug 2018 10:39:01 -0500 Subject: [petsc-users] Solving Linear Systems with Scalar Real and Complex In-Reply-To: References: <405250E7-D339-4F7A-BD0D-B008D6B3FC8D@cnr.it> <3B4B622A-EBCE-4E61-9039-CA8C34F730A4@cnr.it> <0ECD0720-31CA-443F-A44C-6703063B26B5@anl.gov> <583A6898-B577-495D-96C9-FFABA14B5B8D@cnr.it> Message-ID: It looks like ML and hypre are working well now. If you want to debug GAMG you can run with -info, which is very noisy, and grep on GAMG or send the whole output. BTW, what equations are you solving? On Thu, Aug 2, 2018 at 5:12 AM Pierpaolo Minelli wrote: > Thank you very much for the correction. > By rebalancing the matrix coefficients, making them dimensionless, in my > complex problem i managed to obtain a better result with both ML and HYPRE. > GAMG instead seems to be unable to converge and in fact I get unexpected > results. I report the outputs of the three simulations again (i tried to > use also -pc_gamg_square_graph 20 without any improvement). > > Pierpaolo > > *-pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual* > > 0 KSP preconditioned resid norm 1.984853668904e-02 true resid norm > 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.924446712661e-04 true resid norm > 1.204260204811e-04 ||r(i)||/||b|| 4.041323752460e-02 > 2 KSP preconditioned resid norm 5.161509100765e-06 true resid norm > 2.810809726926e-06 ||r(i)||/||b|| 9.432672496933e-04 > 3 KSP preconditioned resid norm 9.297326931238e-08 true resid norm > 4.474617977876e-08 ||r(i)||/||b|| 1.501617328625e-05 > 4 KSP preconditioned resid norm 1.910271882670e-09 true resid norm > 9.637470658283e-10 ||r(i)||/||b|| 3.234196308186e-07 > 0 KSP preconditioned resid norm 2.157687745805e+04 true resid norm > 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.949268476386e+02 true resid norm > 1.243419788627e+02 ||r(i)||/||b|| 3.907665598415e-02 > 2 KSP preconditioned resid norm 5.078054475792e+00 true resid norm > 2.745355604400e+00 ||r(i)||/||b|| 8.627763325675e-04 > 3 KSP preconditioned resid norm 8.663802743529e-02 true resid norm > 4.254290979292e-02 ||r(i)||/||b|| 1.336985839979e-05 > 4 KSP preconditioned resid norm 1.795605563039e-03 true resid norm > 9.040507428245e-04 ||r(i)||/||b|| 2.841138623714e-07 > 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm > 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm > 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 > 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm > 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 > 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm > 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 > 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm > 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 > 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm > 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 > > *-pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual* > > 0 KSP preconditioned resid norm 1.825767020538e-02 true resid norm > 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 6.495628259383e-04 true resid norm > 3.739440526742e-04 ||r(i)||/||b|| 1.254902367550e-01 > 2 KSP preconditioned resid norm 4.971875712015e-05 true resid norm > 2.118856024328e-05 ||r(i)||/||b|| 7.110575559127e-03 > 3 KSP preconditioned resid norm 3.726806462912e-06 true resid norm > 1.370355844514e-06 ||r(i)||/||b|| 4.598716790303e-04 > 4 KSP preconditioned resid norm 2.496898447120e-07 true resid norm > 9.494701893753e-08 ||r(i)||/||b|| 3.186285167645e-05 > 5 KSP preconditioned resid norm 1.541814409235e-08 true resid norm > 6.216753346769e-09 ||r(i)||/||b|| 2.086252859898e-06 > 6 KSP preconditioned resid norm 1.153890845138e-09 true resid norm > 5.290239857745e-10 ||r(i)||/||b|| 1.775328281039e-07 > 0 KSP preconditioned resid norm 1.961448048639e+04 true resid norm > 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.940694187370e+02 true resid norm > 4.331011797078e+02 ||r(i)||/||b|| 1.361096707691e-01 > 2 KSP preconditioned resid norm 6.141876183555e+01 true resid norm > 2.734346095946e+01 ||r(i)||/||b|| 8.593164007057e-03 > 3 KSP preconditioned resid norm 4.872887149917e+00 true resid norm > 1.774255242955e+00 ||r(i)||/||b|| 5.575909470898e-04 > 4 KSP preconditioned resid norm 3.088357668927e-01 true resid norm > 1.183728642343e-01 ||r(i)||/||b|| 3.720075662179e-05 > 5 KSP preconditioned resid norm 2.030016543073e-02 true resid norm > 7.924623904393e-03 ||r(i)||/||b|| 2.490452580442e-06 > 6 KSP preconditioned resid norm 1.458276941086e-03 true resid norm > 6.781128809522e-04 ||r(i)||/||b|| 2.131089114856e-07 > 0 KSP preconditioned resid norm 6.230592591466e+02 true resid norm > 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.825349376322e+01 true resid norm > 7.755266613308e+02 ||r(i)||/||b|| 4.126287287931e+00 > 2 KSP preconditioned resid norm 4.321561767174e+00 true resid norm > 2.170558998883e+02 ||r(i)||/||b|| 1.154873255992e+00 > 3 KSP preconditioned resid norm 2.806349660119e-01 true resid norm > 2.931496742303e+01 ||r(i)||/||b|| 1.559739767247e-01 > 4 KSP preconditioned resid norm 1.707567397460e-02 true resid norm > 2.684913551118e+00 ||r(i)||/||b|| 1.428542074383e-02 > 5 KSP preconditioned resid norm 1.741069717192e-03 true resid norm > 2.914639372698e-01 ||r(i)||/||b|| 1.550770591410e-03 > 6 KSP preconditioned resid norm 1.460913620440e-04 true resid norm > 3.460791330512e-02 ||r(i)||/||b|| 1.841357619965e-04 > 7 KSP preconditioned resid norm 1.741167177387e-05 true resid norm > 3.396573365236e-03 ||r(i)||/||b|| 1.807189642642e-05 > > *-pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true > -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 > -ksp_max_it 30 -ksp_monitor_true_residual* > > 0 KSP preconditioned resid norm 1.244808265687e+15 true resid norm > 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.064535247522e+14 true resid norm > 2.984544079484e-03 ||r(i)||/||b|| 1.001569995463e+00 > 2 KSP preconditioned resid norm 5.618140421534e+12 true resid norm > 2.985603691163e-03 ||r(i)||/||b|| 1.001925585876e+00 > 3 KSP preconditioned resid norm 1.553607230691e+12 true resid norm > 2.986068066312e-03 ||r(i)||/||b|| 1.002081423486e+00 > 4 KSP preconditioned resid norm 2.754119595329e+11 true resid norm > 2.986119711375e-03 ||r(i)||/||b|| 1.002098754825e+00 > 5 KSP preconditioned resid norm 2.443949058171e+11 true resid norm > 2.986120048522e-03 ||r(i)||/||b|| 1.002098867967e+00 > 6 KSP preconditioned resid norm 5.097094561118e+10 true resid norm > 2.986121310105e-03 ||r(i)||/||b|| 1.002099291336e+00 > 7 KSP preconditioned resid norm 5.917979151193e+09 true resid norm > 2.986121369446e-03 ||r(i)||/||b|| 1.002099311250e+00 > 8 KSP preconditioned resid norm 5.917672183458e+09 true resid norm > 2.986121369424e-03 ||r(i)||/||b|| 1.002099311243e+00 > 9 KSP preconditioned resid norm 4.641300731865e+08 true resid norm > 2.986121370475e-03 ||r(i)||/||b|| 1.002099311595e+00 > 10 KSP preconditioned resid norm 4.634203577645e+08 true resid norm > 2.986121382852e-03 ||r(i)||/||b|| 1.002099315749e+00 > 11 KSP preconditioned resid norm 4.587254969048e+08 true resid norm > 2.986121419848e-03 ||r(i)||/||b|| 1.002099328164e+00 > 12 KSP preconditioned resid norm 4.586269695339e+08 true resid norm > 2.986121536662e-03 ||r(i)||/||b|| 1.002099367365e+00 > 13 KSP preconditioned resid norm 4.581015928356e+08 true resid norm > 2.986122475198e-03 ||r(i)||/||b|| 1.002099682325e+00 > 14 KSP preconditioned resid norm 4.571106094607e+08 true resid norm > 2.986124378604e-03 ||r(i)||/||b|| 1.002100321080e+00 > 15 KSP preconditioned resid norm 4.536929046842e+08 true resid norm > 2.986134395719e-03 ||r(i)||/||b|| 1.002103682680e+00 > 16 KSP preconditioned resid norm 4.535016059345e+08 true resid norm > 2.986135027367e-03 ||r(i)||/||b|| 1.002103894652e+00 > 17 KSP preconditioned resid norm 4.534978476038e+08 true resid norm > 2.986135001016e-03 ||r(i)||/||b|| 1.002103885808e+00 > 18 KSP preconditioned resid norm 4.467301680293e+08 true resid norm > 2.986152055223e-03 ||r(i)||/||b|| 1.002109608955e+00 > 19 KSP preconditioned resid norm 4.310227073192e+08 true resid norm > 2.986506137056e-03 ||r(i)||/||b|| 1.002228433717e+00 > 20 KSP preconditioned resid norm 3.520200847767e+08 true resid norm > 2.989053346159e-03 ||r(i)||/||b|| 1.003083240395e+00 > 21 KSP preconditioned resid norm 3.273563895836e+08 true resid norm > 2.990009521982e-03 ||r(i)||/||b|| 1.003404119226e+00 > 22 KSP preconditioned resid norm 1.692012480634e+08 true resid norm > 2.999909265923e-03 ||r(i)||/||b|| 1.006726330669e+00 > 23 KSP preconditioned resid norm 1.616841528495e+08 true resid norm > 3.002594301034e-03 ||r(i)||/||b|| 1.007627389770e+00 > 24 KSP preconditioned resid norm 1.588031462511e+08 true resid norm > 3.003789395992e-03 ||r(i)||/||b|| 1.008028446420e+00 > 25 KSP preconditioned resid norm 1.585650863283e+08 true resid norm > 3.003987247746e-03 ||r(i)||/||b|| 1.008094842618e+00 > 26 KSP preconditioned resid norm 1.482994894928e+08 true resid norm > 3.004024810257e-03 ||r(i)||/||b|| 1.008107448056e+00 > 27 KSP preconditioned resid norm 1.293588493466e+08 true resid norm > 3.005576275194e-03 ||r(i)||/||b|| 1.008628097337e+00 > 28 KSP preconditioned resid norm 1.082178475680e+08 true resid norm > 3.010519288328e-03 ||r(i)||/||b|| 1.010286901332e+00 > 0 KSP preconditioned resid norm 4.688654651573e+20 true resid norm > 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 4.673814485341e+20 true resid norm > 3.182057223735e+03 ||r(i)||/||b|| 1.000017504878e+00 > 2 KSP preconditioned resid norm 1.203925723825e+19 true resid norm > 3.185040065807e+03 ||r(i)||/||b|| 1.000954915514e+00 > 3 KSP preconditioned resid norm 3.042270671882e+18 true resid norm > 3.187076078024e+03 ||r(i)||/||b|| 1.001594768198e+00 > 4 KSP preconditioned resid norm 5.678481873896e+17 true resid norm > 3.187261697361e+03 ||r(i)||/||b|| 1.001653102343e+00 > 5 KSP preconditioned resid norm 4.462228267454e+17 true resid norm > 3.187264158420e+03 ||r(i)||/||b|| 1.001653875774e+00 > 6 KSP preconditioned resid norm 9.314909592131e+16 true resid norm > 3.187268102332e+03 ||r(i)||/||b|| 1.001655115218e+00 > 7 KSP preconditioned resid norm 8.843621410196e+15 true resid norm > 3.187268285359e+03 ||r(i)||/||b|| 1.001655172737e+00 > 8 KSP preconditioned resid norm 8.214565462317e+15 true resid norm > 3.187268286281e+03 ||r(i)||/||b|| 1.001655173027e+00 > 9 KSP preconditioned resid norm 4.525549868436e+14 true resid norm > 3.187268287235e+03 ||r(i)||/||b|| 1.001655173327e+00 > 10 KSP preconditioned resid norm 4.522301211733e+14 true resid norm > 3.187268289937e+03 ||r(i)||/||b|| 1.001655174176e+00 > 11 KSP preconditioned resid norm 4.295952793336e+14 true resid norm > 3.187268328860e+03 ||r(i)||/||b|| 1.001655186408e+00 > 12 KSP preconditioned resid norm 4.294637249487e+14 true resid norm > 3.187268422725e+03 ||r(i)||/||b|| 1.001655215907e+00 > 13 KSP preconditioned resid norm 4.285778654372e+14 true resid norm > 3.187269536466e+03 ||r(i)||/||b|| 1.001655565920e+00 > 14 KSP preconditioned resid norm 4.162983479677e+14 true resid norm > 3.187285280554e+03 ||r(i)||/||b|| 1.001660513777e+00 > 15 KSP preconditioned resid norm 4.162978556133e+14 true resid norm > 3.187285288668e+03 ||r(i)||/||b|| 1.001660516326e+00 > 16 KSP preconditioned resid norm 4.161875124570e+14 true resid norm > 3.187285309889e+03 ||r(i)||/||b|| 1.001660522996e+00 > 17 KSP preconditioned resid norm 4.117671313790e+14 true resid norm > 3.187289951588e+03 ||r(i)||/||b|| 1.001661981731e+00 > 18 KSP preconditioned resid norm 4.103112320458e+14 true resid norm > 3.187292327095e+03 ||r(i)||/||b|| 1.001662728276e+00 > 19 KSP preconditioned resid norm 4.032611123108e+14 true resid norm > 3.187463967167e+03 ||r(i)||/||b|| 1.001716669191e+00 > 20 KSP preconditioned resid norm 3.432105733172e+14 true resid norm > 3.189686334937e+03 ||r(i)||/||b|| 1.002415087389e+00 > 21 KSP preconditioned resid norm 3.125440416815e+14 true resid norm > 3.191137543657e+03 ||r(i)||/||b|| 1.002871155278e+00 > 22 KSP preconditioned resid norm 2.214281952780e+14 true resid norm > 3.198766855775e+03 ||r(i)||/||b|| 1.005268800931e+00 > 23 KSP preconditioned resid norm 2.205574806871e+14 true resid norm > 3.198012835064e+03 ||r(i)||/||b|| 1.005031836647e+00 > 24 KSP preconditioned resid norm 2.202202974538e+14 true resid norm > 3.197792157500e+03 ||r(i)||/||b|| 1.004962484838e+00 > 25 KSP preconditioned resid norm 2.188941573096e+14 true resid norm > 3.197631986560e+03 ||r(i)||/||b|| 1.004912148300e+00 > 26 KSP preconditioned resid norm 1.811445509155e+14 true resid norm > 3.201511171410e+03 ||r(i)||/||b|| 1.006131250435e+00 > 27 KSP preconditioned resid norm 1.333006235872e+14 true resid norm > 3.207865456494e+03 ||r(i)||/||b|| 1.008128196394e+00 > 28 KSP preconditioned resid norm 1.290269724722e+14 true resid norm > 3.209026547700e+03 ||r(i)||/||b|| 1.008493089747e+00 > 29 KSP preconditioned resid norm 8.645848930695e+13 true resid norm > 3.216715733004e+03 ||r(i)||/||b|| 1.010909551603e+00 > 30 KSP preconditioned resid norm 7.051095175336e+13 true resid norm > 3.219405322929e+03 ||r(i)||/||b|| 1.011754802589e+00 > 0 KSP preconditioned resid norm 4.970534641714e+02 true resid norm > 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 9.825390294838e+01 true resid norm > 6.304087699909e+03 ||r(i)||/||b|| 3.354169267824e+01 > 2 KSP preconditioned resid norm 1.317425630977e+01 true resid norm > 1.659038483292e+03 ||r(i)||/||b|| 8.827123224947e+00 > 3 KSP preconditioned resid norm 1.267331175258e+00 true resid norm > 3.723773819327e+02 ||r(i)||/||b|| 1.981280765700e+00 > 4 KSP preconditioned resid norm 1.451198865319e-01 true resid norm > 6.113281457366e+01 ||r(i)||/||b|| 3.252648403059e-01 > 5 KSP preconditioned resid norm 2.428012832580e-02 true resid norm > 9.525516489005e+00 ||r(i)||/||b|| 5.068171032587e-02 > 6 KSP preconditioned resid norm 3.273131599046e-03 true resid norm > 1.693121214500e+00 ||r(i)||/||b|| 9.008464689439e-03 > 7 KSP preconditioned resid norm 3.629020564958e-04 true resid norm > 1.937921370699e-01 ||r(i)||/||b|| 1.031095475584e-03 > 8 KSP preconditioned resid norm 4.303742583350e-05 true resid norm > 2.733022203972e-02 ||r(i)||/||b|| 1.454138889117e-04 > > *-pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true > -pc_gamg_square_graph 20 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 > -ksp_max_it 30 -ksp_monitor_true_residual* > > 0 KSP preconditioned resid norm 3.031864566839e+14 true resid norm > 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.212883161649e+14 true resid norm > 2.982229202367e-03 ||r(i)||/||b|| 1.000793156052e+00 > 2 KSP preconditioned resid norm 5.312941731712e+12 true resid norm > 2.985627671175e-03 ||r(i)||/||b|| 1.001933633223e+00 > 3 KSP preconditioned resid norm 3.602406845592e+12 true resid norm > 2.985818915765e-03 ||r(i)||/||b|| 1.001997812152e+00 > 4 KSP preconditioned resid norm 6.891073564923e+10 true resid norm > 2.986120881484e-03 ||r(i)||/||b|| 1.002099147497e+00 > 5 KSP preconditioned resid norm 1.267096776171e+09 true resid norm > 2.986121018547e-03 ||r(i)||/||b|| 1.002099193494e+00 > 6 KSP preconditioned resid norm 5.130735430694e+08 true resid norm > 2.986121020564e-03 ||r(i)||/||b|| 1.002099194170e+00 > 7 KSP preconditioned resid norm 5.122457469991e+08 true resid norm > 2.986121025937e-03 ||r(i)||/||b|| 1.002099195974e+00 > 8 KSP preconditioned resid norm 5.115042446514e+08 true resid norm > 2.986121044146e-03 ||r(i)||/||b|| 1.002099202084e+00 > 9 KSP preconditioned resid norm 5.103842476065e+08 true resid norm > 2.986121084005e-03 ||r(i)||/||b|| 1.002099215460e+00 > 10 KSP preconditioned resid norm 5.103414725629e+08 true resid norm > 2.986121151167e-03 ||r(i)||/||b|| 1.002099237999e+00 > 11 KSP preconditioned resid norm 5.103050707318e+08 true resid norm > 2.986121488999e-03 ||r(i)||/||b|| 1.002099351370e+00 > 12 KSP preconditioned resid norm 5.101511376685e+08 true resid norm > 2.986123179301e-03 ||r(i)||/||b|| 1.002099918611e+00 > 13 KSP preconditioned resid norm 5.101218154297e+08 true resid norm > 2.986123839891e-03 ||r(i)||/||b|| 1.002100140296e+00 > 14 KSP preconditioned resid norm 5.095285470767e+08 true resid norm > 2.986138347067e-03 ||r(i)||/||b|| 1.002105008695e+00 > 15 KSP preconditioned resid norm 5.082373114330e+08 true resid norm > 2.986170368742e-03 ||r(i)||/||b|| 1.002115754708e+00 > 16 KSP preconditioned resid norm 5.079055966450e+08 true resid norm > 2.986178765357e-03 ||r(i)||/||b|| 1.002118572491e+00 > 17 KSP preconditioned resid norm 4.278159855635e+08 true resid norm > 2.989173921061e-03 ||r(i)||/||b|| 1.003123703595e+00 > 18 KSP preconditioned resid norm 3.704767561598e+08 true resid norm > 2.991993992919e-03 ||r(i)||/||b|| 1.004070079082e+00 > 19 KSP preconditioned resid norm 3.690160215681e+08 true resid norm > 2.992090282533e-03 ||r(i)||/||b|| 1.004102392489e+00 > 20 KSP preconditioned resid norm 3.135406273863e+08 true resid norm > 2.996344554486e-03 ||r(i)||/||b|| 1.005530064867e+00 > 21 KSP preconditioned resid norm 1.938459923255e+08 true resid norm > 3.005844334042e-03 ||r(i)||/||b|| 1.008718054025e+00 > 22 KSP preconditioned resid norm 1.827826394560e+08 true resid norm > 3.007605246670e-03 ||r(i)||/||b|| 1.009308990933e+00 > 23 KSP preconditioned resid norm 1.108660460314e+08 true resid norm > 3.020965814060e-03 ||r(i)||/||b|| 1.013792604867e+00 > 24 KSP preconditioned resid norm 1.051235646374e+08 true resid norm > 3.021541389078e-03 ||r(i)||/||b|| 1.013985759551e+00 > 25 KSP preconditioned resid norm 7.173044522784e+07 true resid norm > 3.024254088703e-03 ||r(i)||/||b|| 1.014896102464e+00 > 26 KSP preconditioned resid norm 6.350860057272e+07 true resid norm > 3.023434854983e-03 ||r(i)||/||b|| 1.014621179430e+00 > 27 KSP preconditioned resid norm 5.267152287984e+07 true resid norm > 3.022203752421e-03 ||r(i)||/||b|| 1.014208039146e+00 > 28 KSP preconditioned resid norm 4.650599761568e+07 true resid norm > 3.022093139351e-03 ||r(i)||/||b|| 1.014170918994e+00 > 29 KSP preconditioned resid norm 3.141941642480e+07 true resid norm > 3.023444082486e-03 ||r(i)||/||b|| 1.014624276047e+00 > 30 KSP preconditioned resid norm 2.065598123858e+07 true resid norm > 3.024498453617e-03 ||r(i)||/||b|| 1.014978107808e+00 > 0 KSP preconditioned resid norm 4.257133849062e+20 true resid norm > 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.793742274994e+19 true resid norm > 3.184922256681e+03 ||r(i)||/||b|| 1.000917891922e+00 > 2 KSP preconditioned resid norm 1.137325629643e+19 true resid norm > 3.185147137826e+03 ||r(i)||/||b|| 1.000988564781e+00 > 3 KSP preconditioned resid norm 7.164960007703e+18 true resid norm > 3.186117509159e+03 ||r(i)||/||b|| 1.001293521056e+00 > 4 KSP preconditioned resid norm 1.109461464210e+17 true resid norm > 3.187268097356e+03 ||r(i)||/||b|| 1.001655113654e+00 > 5 KSP preconditioned resid norm 1.984768045830e+15 true resid norm > 3.187268427639e+03 ||r(i)||/||b|| 1.001655217451e+00 > 6 KSP preconditioned resid norm 7.354105789290e+14 true resid norm > 3.187268429720e+03 ||r(i)||/||b|| 1.001655218105e+00 > 7 KSP preconditioned resid norm 6.662738391887e+14 true resid norm > 3.187268442496e+03 ||r(i)||/||b|| 1.001655222120e+00 > 8 KSP preconditioned resid norm 5.358556594776e+14 true resid norm > 3.187268479547e+03 ||r(i)||/||b|| 1.001655233764e+00 > 9 KSP preconditioned resid norm 5.055368509046e+14 true resid norm > 3.187268491131e+03 ||r(i)||/||b|| 1.001655237405e+00 > 10 KSP preconditioned resid norm 5.050370080533e+14 true resid norm > 3.187268557074e+03 ||r(i)||/||b|| 1.001655258129e+00 > 11 KSP preconditioned resid norm 5.049526065770e+14 true resid norm > 3.187269209319e+03 ||r(i)||/||b|| 1.001655463108e+00 > 12 KSP preconditioned resid norm 5.048442087580e+14 true resid norm > 3.187270145328e+03 ||r(i)||/||b|| 1.001655757265e+00 > 13 KSP preconditioned resid norm 5.048317293084e+14 true resid norm > 3.187270420057e+03 ||r(i)||/||b|| 1.001655843604e+00 > 14 KSP preconditioned resid norm 5.046339848740e+14 true resid norm > 3.187276012517e+03 ||r(i)||/||b|| 1.001657601133e+00 > 15 KSP preconditioned resid norm 5.036574780195e+14 true resid norm > 3.187304228896e+03 ||r(i)||/||b|| 1.001666468627e+00 > 16 KSP preconditioned resid norm 5.033948448037e+14 true resid norm > 3.187311929535e+03 ||r(i)||/||b|| 1.001668888688e+00 > 17 KSP preconditioned resid norm 4.374073117273e+14 true resid norm > 3.190248474209e+03 ||r(i)||/||b|| 1.002591749552e+00 > 18 KSP preconditioned resid norm 3.454318321770e+14 true resid norm > 3.195991944291e+03 ||r(i)||/||b|| 1.004396736143e+00 > 19 KSP preconditioned resid norm 3.438483821871e+14 true resid norm > 3.196113376292e+03 ||r(i)||/||b|| 1.004434898287e+00 > 20 KSP preconditioned resid norm 3.090011643835e+14 true resid norm > 3.199125186774e+03 ||r(i)||/||b|| 1.005381412756e+00 > 21 KSP preconditioned resid norm 1.976112359751e+14 true resid norm > 3.209202875553e+03 ||r(i)||/||b|| 1.008548503879e+00 > 22 KSP preconditioned resid norm 1.874048396302e+14 true resid norm > 3.210733816807e+03 ||r(i)||/||b|| 1.009029629122e+00 > 23 KSP preconditioned resid norm 1.086663247242e+14 true resid norm > 3.224219602770e+03 ||r(i)||/||b|| 1.013267774787e+00 > 24 KSP preconditioned resid norm 1.036005882413e+14 true resid norm > 3.224749127723e+03 ||r(i)||/||b|| 1.013434187326e+00 > 25 KSP preconditioned resid norm 6.943244220256e+13 true resid norm > 3.227732423395e+03 ||r(i)||/||b|| 1.014371740514e+00 > 26 KSP preconditioned resid norm 6.064453821356e+13 true resid norm > 3.227303114420e+03 ||r(i)||/||b|| 1.014236822611e+00 > 27 KSP preconditioned resid norm 5.237876331038e+13 true resid norm > 3.226320811775e+03 ||r(i)||/||b|| 1.013928116710e+00 > 28 KSP preconditioned resid norm 4.407157490353e+13 true resid norm > 3.226123552298e+03 ||r(i)||/||b|| 1.013866124447e+00 > 29 KSP preconditioned resid norm 3.691867703712e+13 true resid norm > 3.226578266524e+03 ||r(i)||/||b|| 1.014009026398e+00 > 0 KSP preconditioned resid norm 4.105203293801e+02 true resid norm > 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.404700393158e+02 true resid norm > 5.941722233814e+03 ||r(i)||/||b|| 3.161368157187e+01 > 2 KSP preconditioned resid norm 3.849004101235e+01 true resid norm > 3.456178528017e+03 ||r(i)||/||b|| 1.838903320294e+01 > 3 KSP preconditioned resid norm 8.384263059954e+00 true resid norm > 1.401839902990e+03 ||r(i)||/||b|| 7.458665781386e+00 > 4 KSP preconditioned resid norm 1.363029002549e+00 true resid norm > 3.612540200618e+02 ||r(i)||/||b|| 1.922097517753e+00 > 5 KSP preconditioned resid norm 3.734525206097e-01 true resid norm > 1.272038960182e+02 ||r(i)||/||b|| 6.768043515285e-01 > 6 KSP preconditioned resid norm 8.146021124788e-02 true resid norm > 3.196642795661e+01 ||r(i)||/||b|| 1.700814064749e-01 > 7 KSP preconditioned resid norm 2.110568459516e-02 true resid norm > 6.793208791728e+00 ||r(i)||/||b|| 3.614412305757e-02 > 8 KSP preconditioned resid norm 4.044708317961e-03 true resid norm > 1.976363197299e+00 ||r(i)||/||b|| 1.051548933644e-02 > 9 KSP preconditioned resid norm 9.154675861687e-04 true resid norm > 3.458820713849e-01 ||r(i)||/||b|| 1.840309128547e-03 > 10 KSP preconditioned resid norm 2.106487039520e-04 true resid norm > 1.064965566696e-01 ||r(i)||/||b|| 5.666283442018e-04 > 11 KSP preconditioned resid norm 5.145654020522e-05 true resid norm > 2.436255895394e-02 ||r(i)||/||b|| 1.296240636532e-04 > 12 KSP preconditioned resid norm 1.223910887488e-05 true resid norm > 4.954689842368e-03 ||r(i)||/||b|| 2.636205140533e-05 > > Il giorno 01 ago 2018, alle ore 15:41, Matthew Knepley > ha scritto: > > On Wed, Aug 1, 2018 at 9:02 AM Pierpaolo Minelli > wrote: > >> Il giorno 27 lug 2018, alle ore 18:32, Smith, Barry F. < >> bsmith at mcs.anl.gov> ha scritto: >> >> On Jul 27, 2018, at 3:26 AM, Pierpaolo Minelli >> wrote: >> >> >> Finally, I have a question. In my simulation I solve the two systems at >> each step of the calculation, and it was my habit to use the following >> option after the first resolution and before solving the system in the >> second time step: >> >> call KSPSetInitialGuessNonzero(ksp,PETSC_TRUE,ierr) >> >> Since this option was incompatible with the use of MUMPS or SuperLU_Dist, >> I commented on it and noticed, to my surprise, that iterative methods were >> not affected by this comment, rather they were slightly faster. Is this >> normal? Or do I use this command incorrectly? >> >> >> Presuming this is a linear problem? >> >> >> You should run with -ksp_monitor_true_residual and compare the final >> residual norms (at linear system convergence). Since KSP uses a relative >> decrease in the residual norm to declare convergence what you have told us >> isn't enough to determine if one is converging "faster" to the solution >> then the other. >> >> Barry >> >> >> Yes, there are two linear problems. The first in the field of complex >> numbers (which I divided into two problems in the field of real numbers as >> suggested by Matthew) and the second in the field of real numbers. >> >> These are the results obtained using the option >> -ksp_monitor_true_residual: >> >> *-pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true >> -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 >> -ksp_monitor_true_residual* >> >> 0 KSP preconditioned resid norm 1.324344286254e-02 true resid norm >> 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 3.399266083153e-03 true resid norm >> 1.196951495628e+05 ||r(i)||/||b|| 4.016796777391e+07 >> 2 KSP preconditioned resid norm 6.287919852336e-04 true resid norm >> 4.429876706490e+04 ||r(i)||/||b|| 1.486602802524e+07 >> 3 KSP preconditioned resid norm 8.836547690039e-05 true resid norm >> 1.182383826632e+04 ||r(i)||/||b|| 3.967909778970e+06 >> 4 KSP preconditioned resid norm 1.291370058561e-05 true resid norm >> 2.801893692950e+03 ||r(i)||/||b|| 9.402751571421e+05 >> 5 KSP preconditioned resid norm 2.073922228951e-06 true resid norm >> 6.312112895919e+02 ||r(i)||/||b|| 2.118254150770e+05 >> 6 KSP preconditioned resid norm 3.283811876800e-07 true resid norm >> 8.777865833701e+01 ||r(i)||/||b|| 2.945725313178e+04 >> 7 KSP preconditioned resid norm 5.414680273500e-08 true resid norm >> 1.610127004050e+01 ||r(i)||/||b|| 5.403354258448e+03 >> 8 KSP preconditioned resid norm 9.645834363683e-09 true resid norm >> 3.006444251909e+00 ||r(i)||/||b|| 1.008919377818e+03 >> 9 KSP preconditioned resid norm 1.915420455785e-09 true resid norm >> 6.672996533262e-01 ||r(i)||/||b|| 2.239361500298e+02 >> 10 KSP preconditioned resid norm 3.334928638696e-10 true resid norm >> 1.185976397497e-01 ||r(i)||/||b|| 3.979965929219e+01 >> > > You can see from the "true resid norm" that your complex problem is not > actually being solved. ML and Hypre have similar results. > I would guess that your coarse grid is near singular. > > The real problem is being solved correctly, although you are still 100x > off the true residual so the preconditioner is not great. > Have you tested with a manufactured solution? > > Thanks, > > Matt > > > > > > > > > > >> 0 KSP preconditioned resid norm 1.416256896904e+04 true resid norm >> 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 3.781264980774e+03 true resid norm >> 1.283809201228e+11 ||r(i)||/||b|| 1.938227104995e+05 >> 2 KSP preconditioned resid norm 7.392413714593e+02 true resid norm >> 4.990467508600e+10 ||r(i)||/||b|| 7.534343407504e+04 >> 3 KSP preconditioned resid norm 1.087641767696e+02 true resid norm >> 1.367263690390e+10 ||r(i)||/||b|| 2.064222270610e+04 >> 4 KSP preconditioned resid norm 1.627726591174e+01 true resid norm >> 3.451534923895e+09 ||r(i)||/||b|| 5.210944536719e+03 >> 5 KSP preconditioned resid norm 2.564636460142e+00 true resid norm >> 7.980525032990e+08 ||r(i)||/||b|| 1.204857381941e+03 >> 6 KSP preconditioned resid norm 4.252626820180e-01 true resid norm >> 1.151817528111e+08 ||r(i)||/||b|| 1.738953070953e+02 >> 7 KSP preconditioned resid norm 6.758292325957e-02 true resid norm >> 2.065701091779e+07 ||r(i)||/||b|| 3.118686050134e+01 >> 8 KSP preconditioned resid norm 1.099617201063e-02 true resid norm >> 3.470561062696e+06 ||r(i)||/||b|| 5.239669192917e+00 >> 9 KSP preconditioned resid norm 2.195352537111e-03 true resid norm >> 7.056823048483e+05 ||r(i)||/||b|| 1.065401750871e+00 >> 10 KSP preconditioned resid norm 4.380752631896e-04 true resid norm >> 1.440377395627e+05 ||r(i)||/||b|| 2.174605468598e-01 >> >> 0 KSP preconditioned resid norm 4.970534641714e+02 true resid norm >> 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 9.825390294838e+01 true resid norm >> 6.304087699909e+03 ||r(i)||/||b|| 3.354169267824e+01 >> 2 KSP preconditioned resid norm 1.317425630977e+01 true resid norm >> 1.659038483292e+03 ||r(i)||/||b|| 8.827123224947e+00 >> 3 KSP preconditioned resid norm 1.267331175258e+00 true resid norm >> 3.723773819327e+02 ||r(i)||/||b|| 1.981280765700e+00 >> 4 KSP preconditioned resid norm 1.451198865319e-01 true resid norm >> 6.113281457366e+01 ||r(i)||/||b|| 3.252648403059e-01 >> 5 KSP preconditioned resid norm 2.428012832580e-02 true resid norm >> 9.525516489005e+00 ||r(i)||/||b|| 5.068171032587e-02 >> 6 KSP preconditioned resid norm 3.273131599046e-03 true resid norm >> 1.693121214500e+00 ||r(i)||/||b|| 9.008464689439e-03 >> 7 KSP preconditioned resid norm 3.629020564958e-04 true resid norm >> 1.937921370699e-01 ||r(i)||/||b|| 1.031095475584e-03 >> 8 KSP preconditioned resid norm 4.303742583350e-05 true resid norm >> 2.733022203972e-02 ||r(i)||/||b|| 1.454138889117e-04 >> >> *-pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual* >> >> 0 KSP preconditioned resid norm 1.825767020537e-02 true resid norm >> 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 6.495628259378e-04 true resid norm >> 1.373525306349e+04 ||r(i)||/||b|| 4.609353047603e+06 >> 2 KSP preconditioned resid norm 4.971875712010e-05 true resid norm >> 2.154150315236e+03 ||r(i)||/||b|| 7.229018114651e+05 >> 3 KSP preconditioned resid norm 3.726806462903e-06 true resid norm >> 3.000693510070e+02 ||r(i)||/||b|| 1.006989511706e+05 >> 4 KSP preconditioned resid norm 2.496898447113e-07 true resid norm >> 3.004338446358e+01 ||r(i)||/||b|| 1.008212699813e+04 >> 5 KSP preconditioned resid norm 1.541814409235e-08 true resid norm >> 2.256927674575e+00 ||r(i)||/||b|| 7.573924125705e+02 >> 6 KSP preconditioned resid norm 1.153890845088e-09 true resid norm >> 2.007294077611e-01 ||r(i)||/||b|| 6.736189738408e+01 >> 0 KSP preconditioned resid norm 1.961448048638e+04 true resid norm >> 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 7.940694187362e+02 true resid norm >> 1.483756468402e+10 ||r(i)||/||b|| 2.240096894085e+04 >> 2 KSP preconditioned resid norm 6.141876183549e+01 true resid norm >> 2.581042149104e+09 ||r(i)||/||b|| 3.896720671376e+03 >> 3 KSP preconditioned resid norm 4.872887149903e+00 true resid norm >> 3.544664743366e+08 ||r(i)||/||b|| 5.351547003355e+02 >> 4 KSP preconditioned resid norm 3.088357668912e-01 true resid norm >> 3.689655474675e+07 ||r(i)||/||b|| 5.570446326655e+01 >> 5 KSP preconditioned resid norm 2.030016543101e-02 true resid norm >> 2.847019997470e+06 ||r(i)||/||b|| 4.298279933093e+00 >> 6 KSP preconditioned resid norm 1.458276940703e-03 true resid norm >> 2.567051860886e+05 ||r(i)||/||b|| 3.875598875547e-01 >> >> 0 KSP preconditioned resid norm 6.230592591466e+02 true resid norm >> 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 3.825349376322e+01 true resid norm >> 7.755266613308e+02 ||r(i)||/||b|| 4.126287287931e+00 >> 2 KSP preconditioned resid norm 4.321561767174e+00 true resid norm >> 2.170558998883e+02 ||r(i)||/||b|| 1.154873255992e+00 >> 3 KSP preconditioned resid norm 2.806349660119e-01 true resid norm >> 2.931496742303e+01 ||r(i)||/||b|| 1.559739767247e-01 >> 4 KSP preconditioned resid norm 1.707567397460e-02 true resid norm >> 2.684913551118e+00 ||r(i)||/||b|| 1.428542074383e-02 >> 5 KSP preconditioned resid norm 1.741069717192e-03 true resid norm >> 2.914639372698e-01 ||r(i)||/||b|| 1.550770591410e-03 >> 6 KSP preconditioned resid norm 1.460913620440e-04 true resid norm >> 3.460791330512e-02 ||r(i)||/||b|| 1.841357619965e-04 >> 7 KSP preconditioned resid norm 1.741167177387e-05 true resid norm >> 3.396573365236e-03 ||r(i)||/||b|| 1.807189642642e-05 >> >> *-pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual* >> >> 0 KSP preconditioned resid norm 1.984853668903e-02 true resid norm >> 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 1.924446712660e-04 true resid norm >> 8.461145171168e+03 ||r(i)||/||b|| 2.839438421750e+06 >> 2 KSP preconditioned resid norm 5.161509100761e-06 true resid norm >> 4.501007519328e+02 ||r(i)||/||b|| 1.510473278548e+05 >> 3 KSP preconditioned resid norm 9.297326931235e-08 true resid norm >> 1.474595580807e+01 ||r(i)||/||b|| 4.948530327732e+03 >> 4 KSP preconditioned resid norm 1.910271882618e-09 true resid norm >> 3.603243780988e-01 ||r(i)||/||b|| 1.209196701829e+02 >> 0 KSP preconditioned resid norm 2.157687745804e+04 true resid norm >> 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 1.949268476385e+02 true resid norm >> 8.974916757495e+09 ||r(i)||/||b|| 1.354985375382e+04 >> 2 KSP preconditioned resid norm 5.078054475786e+00 true resid norm >> 4.502684440161e+08 ||r(i)||/||b|| 6.797914377626e+02 >> 3 KSP preconditioned resid norm 8.663802743525e-02 true resid norm >> 1.432117031381e+07 ||r(i)||/||b|| 2.162134408362e+01 >> 4 KSP preconditioned resid norm 1.795605563041e-03 true resid norm >> 3.389868548833e+05 ||r(i)||/||b|| 5.117843911255e-01 >> >> 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm >> 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm >> 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 >> 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm >> 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 >> 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm >> 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 >> 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm >> 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 >> 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm >> 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 >> >> Thanks >> >> Pierpaolo >> >> >> Thanks >> >> Pierpaolo >> >> Il giorno 23 lug 2018, alle ore 15:43, Mark Adams ha >> scritto: >> >> Note, as Barry said, GAMG works with native complex numbers. You can >> start with your original complex build and use '-pc_type gamg'. >> Mark >> >> On Mon, Jul 23, 2018 at 6:52 AM Pierpaolo Minelli < >> pierpaolo.minelli at cnr.it> wrote: >> >> >> Il giorno 20 lug 2018, alle ore 19:58, Smith, Barry F. < >> bsmith at mcs.anl.gov> ha scritto: >> >> >> >> On Jul 20, 2018, at 7:01 AM, Pierpaolo Minelli >> wrote: >> >> Hi, >> >> in my code I have to solve both a system in the field of real numbers and >> in the field of complex numbers. >> My approach has been as follows. >> First I configured PETSc with the --with-scalar-type=complex option. >> Using this option I have unfortunately lost the possibility to use the >> two preconditioners ML and Hypre. >> >> >> You should still be able to use the PETSc PCGAMG algebraic multigrid >> solver. Have you tried that? If there are issues let us know because we >> would like to continue to improve the performance of PCGAMG to get it to be >> closer to as good as ML and hypre. >> >> Barry >> >> >> I will try to convert, as suggested by Matthew, my complex system in a >> system twice as large in real numbers. When i finish, i will try to use ML, >> Hypre and GAMG and i let you know if there are any performance differences. >> >> Thanks >> >> Pierpaolo >> >> >> I later created two subspaces of Krylov and tried to solve the two >> systems as I used to when solving the only equation in the real numbers >> field. >> In order to correctly solve the system in the field of real numbers I had >> to transform the coefficients from real to complex with an imaginary part >> equal to zero. >> >> Is there a possibility to use a different and better approach to solve my >> problem? >> >> Perhaps an approach where you can continue to use ML and Hypre for system >> solving in the real numbers field or where you don't need to use complex >> numbers when real numbers would actually suffice? >> >> Thanks in advance >> >> Pierpaolo >> >> >> >> >> >> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mcygorek at uottawa.ca Thu Aug 2 15:32:21 2018 From: mcygorek at uottawa.ca (Moritz Cygorek) Date: Thu, 2 Aug 2018 20:32:21 +0000 Subject: [petsc-users] memory corruption when using harmonic extraction with SLEPc Message-ID: <2aa8cc5756394b639a54bdbf9aa4f887@uottawa.ca> Hi, I want to diagonalize a huge sparse matrix and I'm using the Kryov-Schur method with harmonic extraction (command line option -eps_harmonic ) implemented in SLEPc. I manually distribute a sparse matrix across several CPUs and everything works fine when: - I do _not_ use harmonic extraction - I use harmonic extraction on only a single CPU If I try do use harmonic extraction on multiple CPUs, I get a memory corruption. I'm not quite sure where to look at, but somewhere in the output, I find: [1]PETSC ERROR: PetscMallocValidate: error detected at PetscSignalHandlerDefault() line 145 in /home/applications/sources/libraries/petsc-3.9.3/src/sys/error/signal.c [1]PETSC ERROR: Memory [id=0(9072)] at address 0x145bcd0 is corrupted (probably write past end of array) [1]PETSC ERROR: Memory originally allocated in DSAllocateWork_Private() line 74 in /home/applications/sources/libraries/slepc-3.9.2/src/sys/classes/ds/interface/dspriv.c Now, I have the feeling that this might be a bug in SLEPc because, if I had messed up the matrix initialization and distribution, I should also get a memory corruption when I don't use harmonic extraction, right? Any suggestions what might be going on? Regards, Moritz -------------- next part -------------- An HTML attachment was scrubbed... URL: From dave.mayhem23 at gmail.com Thu Aug 2 23:59:54 2018 From: dave.mayhem23 at gmail.com (Dave May) Date: Fri, 3 Aug 2018 05:59:54 +0100 Subject: [petsc-users] memory corruption when using harmonic extraction with SLEPc In-Reply-To: <2aa8cc5756394b639a54bdbf9aa4f887@uottawa.ca> References: <2aa8cc5756394b639a54bdbf9aa4f887@uottawa.ca> Message-ID: On Thu, 2 Aug 2018 at 21:32, Moritz Cygorek wrote: > Hi, > > > I want to diagonalize a huge sparse matrix and I'm using the Kryov-Schur > method with harmonic extraction (command line option -eps_harmonic ) > implemented in SLEPc. > > > I manually distribute a sparse matrix across several CPUs and everything > works fine when: > > - I do _not_ use harmonic extraction > > - I use harmonic extraction on only a single CPU > > > If I try do use harmonic extraction on multiple CPUs, I get a memory > corruption. > > I'm not quite sure where to look at, but somewhere in the output, I find: > > > > [1]PETSC ERROR: PetscMallocValidate: error detected at > PetscSignalHandlerDefault() line 145 in > /home/applications/sources/libraries/petsc-3.9.3/src/sys/error/signal.c > [1]PETSC ERROR: Memory [id=0(9072)] at address 0x145bcd0 is corrupted > (probably write past end of array) > [1]PETSC ERROR: Memory originally allocated in DSAllocateWork_Private() > line 74 in > /home/applications/sources/libraries/slepc-3.9.2/src/sys/classes/ds/interface/dspriv.c > > > Now, I have the feeling that this might be a bug in SLEPc because, if I > had messed up the matrix initialization and distribution, I should also get > a memory corruption when I don't use harmonic extraction, right? > Not necessarily > Any suggestions what might be going on? > Run your code through valgrind and make sure that your application code is clean. See here http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind If errors are detected in your application code, fix them and see if the slepc errors go away. If your code is valgrind clean, send through the relevant chunk of the valgrind report indicating exactly where the error is occurring Thanks, Dave > Regards, > > Moritz > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mbuerkle at web.de Fri Aug 3 02:07:24 2018 From: mbuerkle at web.de (Marius Buerkle) Date: Fri, 3 Aug 2018 09:07:24 +0200 Subject: [petsc-users] MatDenseGetArrayF90 Message-ID: An HTML attachment was scrubbed... URL: From pierpaolo.minelli at cnr.it Fri Aug 3 03:01:47 2018 From: pierpaolo.minelli at cnr.it (Pierpaolo Minelli) Date: Fri, 3 Aug 2018 10:01:47 +0200 Subject: [petsc-users] Solving Linear Systems with Scalar Real and Complex In-Reply-To: References: <405250E7-D339-4F7A-BD0D-B008D6B3FC8D@cnr.it> <3B4B622A-EBCE-4E61-9039-CA8C34F730A4@cnr.it> <0ECD0720-31CA-443F-A44C-6703063B26B5@anl.gov> <583A6898-B577-495D-96C9-FFABA14B5B8D@cnr.it> Message-ID: In this simulation I'm solving two equations in a two-dimensional domain (z,r) at each time step. The first is an equation derived from the Maxwell equation. Taking advantage of the fact that the domain is axialsymmetric and applying a temporal harmonic approximation, the equation I am solving is the following: The second equation is a Poisson?s equation in cylindrical coordinates (z,r) in the field of real numbers. This is the output obtained using these options (Note that at this moment of development I am only using a processor): -pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 -ksp_max_it 30 -ksp_monitor_true_residual -info | grep GAMG [0] PCSetUp_GAMG(): level 0) N=321201, n data rows=1, n data cols=1, nnz/row (ave)=5, np=1 [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 4.97011 nnz ave. (N=321201) [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square [0] PCGAMGProlongator_AGG(): New grid 45754 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.972526e+00 min=3.461411e-03 PC=jacobi [0] PCSetUp_GAMG(): 1) N=45754, n data cols=1, nnz/row (ave)=10, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 10.7695 nnz ave. (N=45754) [0] PCGAMGProlongator_AGG(): New grid 7893 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=5.686837e+00 min=5.062501e-01 PC=jacobi [0] PCSetUp_GAMG(): 2) N=7893, n data cols=1, nnz/row (ave)=23, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 23.2179 nnz ave. (N=7893) [0] PCGAMGProlongator_AGG(): New grid 752 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.504451e+01 min=2.124898e-02 PC=jacobi [0] PCSetUp_GAMG(): 3) N=752, n data cols=1, nnz/row (ave)=30, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 30.7367 nnz ave. (N=752) [0] PCGAMGProlongator_AGG(): New grid 56 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=7.781296e+00 min=2.212257e-02 PC=jacobi [0] PCSetUp_GAMG(): 4) N=56, n data cols=1, nnz/row (ave)=22, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 22.9643 nnz ave. (N=56) [0] PCGAMGProlongator_AGG(): New grid 6 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.525086e+00 min=1.375043e-01 PC=jacobi [0] PCSetUp_GAMG(): 5) N=6, n data cols=1, nnz/row (ave)=6, 1 active pes [0] PCSetUp_GAMG(): 6 levels, grid complexity = 1.43876 [0] PCSetUp_GAMG(): level 0) N=321201, n data rows=1, n data cols=1, nnz/row (ave)=5, np=1 [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 4.97011 nnz ave. (N=321201) [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square [0] PCGAMGProlongator_AGG(): New grid 45754 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.972526e+00 min=3.461411e-03 PC=jacobi [0] PCSetUp_GAMG(): 1) N=45754, n data cols=1, nnz/row (ave)=10, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 10.7695 nnz ave. (N=45754) [0] PCGAMGProlongator_AGG(): New grid 7893 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=5.686837e+00 min=5.062501e-01 PC=jacobi [0] PCSetUp_GAMG(): 2) N=7893, n data cols=1, nnz/row (ave)=23, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 23.2179 nnz ave. (N=7893) [0] PCGAMGProlongator_AGG(): New grid 752 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.504451e+01 min=2.124898e-02 PC=jacobi [0] PCSetUp_GAMG(): 3) N=752, n data cols=1, nnz/row (ave)=30, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 30.7367 nnz ave. (N=752) [0] PCGAMGProlongator_AGG(): New grid 56 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=7.781296e+00 min=2.212257e-02 PC=jacobi [0] PCSetUp_GAMG(): 4) N=56, n data cols=1, nnz/row (ave)=22, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 22.9643 nnz ave. (N=56) [0] PCGAMGProlongator_AGG(): New grid 6 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.525086e+00 min=1.375043e-01 PC=jacobi [0] PCSetUp_GAMG(): 5) N=6, n data cols=1, nnz/row (ave)=6, 1 active pes [0] PCSetUp_GAMG(): 6 levels, grid complexity = 1.43876 [0] PCSetUp_GAMG(): level 0) N=271201, n data rows=1, n data cols=1, nnz/row (ave)=5, np=1 [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 4.97455 nnz ave. (N=271201) [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square [0] PCGAMGProlongator_AGG(): New grid 38501 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.933798e+00 min=4.684075e-02 PC=jacobi [0] PCSetUp_GAMG(): 1) N=38501, n data cols=1, nnz/row (ave)=10, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 10.7732 nnz ave. (N=38501) [0] PCGAMGProlongator_AGG(): New grid 6664 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.623029e+00 min=1.250957e-02 PC=jacobi [0] PCSetUp_GAMG(): 2) N=6664, n data cols=1, nnz/row (ave)=23, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 23.2098 nnz ave. (N=6664) [0] PCGAMGProlongator_AGG(): New grid 620 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.763329e+00 min=1.611776e-02 PC=jacobi [0] PCSetUp_GAMG(): 3) N=620, n data cols=1, nnz/row (ave)=29, 1 active pes [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 29.6129 nnz ave. (N=620) [0] PCGAMGProlongator_AGG(): New grid 46 nodes [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.497611e+00 min=2.630403e-02 PC=jacobi [0] PCSetUp_GAMG(): 4) N=46, n data cols=1, nnz/row (ave)=20, 1 active pes [0] PCSetUp_GAMG(): 5 levels, grid complexity = 1.43639 > Il giorno 02 ago 2018, alle ore 17:39, Mark Adams ha scritto: > > It looks like ML and hypre are working well now. If you want to debug GAMG you can run with -info, which is very noisy, and grep on GAMG or send the whole output. > > BTW, what equations are you solving? > > On Thu, Aug 2, 2018 at 5:12 AM Pierpaolo Minelli > wrote: > Thank you very much for the correction. > By rebalancing the matrix coefficients, making them dimensionless, in my complex problem i managed to obtain a better result with both ML and HYPRE. GAMG instead seems to be unable to converge and in fact I get unexpected results. I report the outputs of the three simulations again (i tried to use also -pc_gamg_square_graph 20 without any improvement). > > Pierpaolo > > -pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual > > 0 KSP preconditioned resid norm 1.984853668904e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.924446712661e-04 true resid norm 1.204260204811e-04 ||r(i)||/||b|| 4.041323752460e-02 > 2 KSP preconditioned resid norm 5.161509100765e-06 true resid norm 2.810809726926e-06 ||r(i)||/||b|| 9.432672496933e-04 > 3 KSP preconditioned resid norm 9.297326931238e-08 true resid norm 4.474617977876e-08 ||r(i)||/||b|| 1.501617328625e-05 > 4 KSP preconditioned resid norm 1.910271882670e-09 true resid norm 9.637470658283e-10 ||r(i)||/||b|| 3.234196308186e-07 > 0 KSP preconditioned resid norm 2.157687745805e+04 true resid norm 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.949268476386e+02 true resid norm 1.243419788627e+02 ||r(i)||/||b|| 3.907665598415e-02 > 2 KSP preconditioned resid norm 5.078054475792e+00 true resid norm 2.745355604400e+00 ||r(i)||/||b|| 8.627763325675e-04 > 3 KSP preconditioned resid norm 8.663802743529e-02 true resid norm 4.254290979292e-02 ||r(i)||/||b|| 1.336985839979e-05 > 4 KSP preconditioned resid norm 1.795605563039e-03 true resid norm 9.040507428245e-04 ||r(i)||/||b|| 2.841138623714e-07 > 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 > 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 > 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 > 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 > 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 > > -pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual > > 0 KSP preconditioned resid norm 1.825767020538e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 6.495628259383e-04 true resid norm 3.739440526742e-04 ||r(i)||/||b|| 1.254902367550e-01 > 2 KSP preconditioned resid norm 4.971875712015e-05 true resid norm 2.118856024328e-05 ||r(i)||/||b|| 7.110575559127e-03 > 3 KSP preconditioned resid norm 3.726806462912e-06 true resid norm 1.370355844514e-06 ||r(i)||/||b|| 4.598716790303e-04 > 4 KSP preconditioned resid norm 2.496898447120e-07 true resid norm 9.494701893753e-08 ||r(i)||/||b|| 3.186285167645e-05 > 5 KSP preconditioned resid norm 1.541814409235e-08 true resid norm 6.216753346769e-09 ||r(i)||/||b|| 2.086252859898e-06 > 6 KSP preconditioned resid norm 1.153890845138e-09 true resid norm 5.290239857745e-10 ||r(i)||/||b|| 1.775328281039e-07 > 0 KSP preconditioned resid norm 1.961448048639e+04 true resid norm 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.940694187370e+02 true resid norm 4.331011797078e+02 ||r(i)||/||b|| 1.361096707691e-01 > 2 KSP preconditioned resid norm 6.141876183555e+01 true resid norm 2.734346095946e+01 ||r(i)||/||b|| 8.593164007057e-03 > 3 KSP preconditioned resid norm 4.872887149917e+00 true resid norm 1.774255242955e+00 ||r(i)||/||b|| 5.575909470898e-04 > 4 KSP preconditioned resid norm 3.088357668927e-01 true resid norm 1.183728642343e-01 ||r(i)||/||b|| 3.720075662179e-05 > 5 KSP preconditioned resid norm 2.030016543073e-02 true resid norm 7.924623904393e-03 ||r(i)||/||b|| 2.490452580442e-06 > 6 KSP preconditioned resid norm 1.458276941086e-03 true resid norm 6.781128809522e-04 ||r(i)||/||b|| 2.131089114856e-07 > 0 KSP preconditioned resid norm 6.230592591466e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.825349376322e+01 true resid norm 7.755266613308e+02 ||r(i)||/||b|| 4.126287287931e+00 > 2 KSP preconditioned resid norm 4.321561767174e+00 true resid norm 2.170558998883e+02 ||r(i)||/||b|| 1.154873255992e+00 > 3 KSP preconditioned resid norm 2.806349660119e-01 true resid norm 2.931496742303e+01 ||r(i)||/||b|| 1.559739767247e-01 > 4 KSP preconditioned resid norm 1.707567397460e-02 true resid norm 2.684913551118e+00 ||r(i)||/||b|| 1.428542074383e-02 > 5 KSP preconditioned resid norm 1.741069717192e-03 true resid norm 2.914639372698e-01 ||r(i)||/||b|| 1.550770591410e-03 > 6 KSP preconditioned resid norm 1.460913620440e-04 true resid norm 3.460791330512e-02 ||r(i)||/||b|| 1.841357619965e-04 > 7 KSP preconditioned resid norm 1.741167177387e-05 true resid norm 3.396573365236e-03 ||r(i)||/||b|| 1.807189642642e-05 > > -pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 -ksp_max_it 30 -ksp_monitor_true_residual > > 0 KSP preconditioned resid norm 1.244808265687e+15 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.064535247522e+14 true resid norm 2.984544079484e-03 ||r(i)||/||b|| 1.001569995463e+00 > 2 KSP preconditioned resid norm 5.618140421534e+12 true resid norm 2.985603691163e-03 ||r(i)||/||b|| 1.001925585876e+00 > 3 KSP preconditioned resid norm 1.553607230691e+12 true resid norm 2.986068066312e-03 ||r(i)||/||b|| 1.002081423486e+00 > 4 KSP preconditioned resid norm 2.754119595329e+11 true resid norm 2.986119711375e-03 ||r(i)||/||b|| 1.002098754825e+00 > 5 KSP preconditioned resid norm 2.443949058171e+11 true resid norm 2.986120048522e-03 ||r(i)||/||b|| 1.002098867967e+00 > 6 KSP preconditioned resid norm 5.097094561118e+10 true resid norm 2.986121310105e-03 ||r(i)||/||b|| 1.002099291336e+00 > 7 KSP preconditioned resid norm 5.917979151193e+09 true resid norm 2.986121369446e-03 ||r(i)||/||b|| 1.002099311250e+00 > 8 KSP preconditioned resid norm 5.917672183458e+09 true resid norm 2.986121369424e-03 ||r(i)||/||b|| 1.002099311243e+00 > 9 KSP preconditioned resid norm 4.641300731865e+08 true resid norm 2.986121370475e-03 ||r(i)||/||b|| 1.002099311595e+00 > 10 KSP preconditioned resid norm 4.634203577645e+08 true resid norm 2.986121382852e-03 ||r(i)||/||b|| 1.002099315749e+00 > 11 KSP preconditioned resid norm 4.587254969048e+08 true resid norm 2.986121419848e-03 ||r(i)||/||b|| 1.002099328164e+00 > 12 KSP preconditioned resid norm 4.586269695339e+08 true resid norm 2.986121536662e-03 ||r(i)||/||b|| 1.002099367365e+00 > 13 KSP preconditioned resid norm 4.581015928356e+08 true resid norm 2.986122475198e-03 ||r(i)||/||b|| 1.002099682325e+00 > 14 KSP preconditioned resid norm 4.571106094607e+08 true resid norm 2.986124378604e-03 ||r(i)||/||b|| 1.002100321080e+00 > 15 KSP preconditioned resid norm 4.536929046842e+08 true resid norm 2.986134395719e-03 ||r(i)||/||b|| 1.002103682680e+00 > 16 KSP preconditioned resid norm 4.535016059345e+08 true resid norm 2.986135027367e-03 ||r(i)||/||b|| 1.002103894652e+00 > 17 KSP preconditioned resid norm 4.534978476038e+08 true resid norm 2.986135001016e-03 ||r(i)||/||b|| 1.002103885808e+00 > 18 KSP preconditioned resid norm 4.467301680293e+08 true resid norm 2.986152055223e-03 ||r(i)||/||b|| 1.002109608955e+00 > 19 KSP preconditioned resid norm 4.310227073192e+08 true resid norm 2.986506137056e-03 ||r(i)||/||b|| 1.002228433717e+00 > 20 KSP preconditioned resid norm 3.520200847767e+08 true resid norm 2.989053346159e-03 ||r(i)||/||b|| 1.003083240395e+00 > 21 KSP preconditioned resid norm 3.273563895836e+08 true resid norm 2.990009521982e-03 ||r(i)||/||b|| 1.003404119226e+00 > 22 KSP preconditioned resid norm 1.692012480634e+08 true resid norm 2.999909265923e-03 ||r(i)||/||b|| 1.006726330669e+00 > 23 KSP preconditioned resid norm 1.616841528495e+08 true resid norm 3.002594301034e-03 ||r(i)||/||b|| 1.007627389770e+00 > 24 KSP preconditioned resid norm 1.588031462511e+08 true resid norm 3.003789395992e-03 ||r(i)||/||b|| 1.008028446420e+00 > 25 KSP preconditioned resid norm 1.585650863283e+08 true resid norm 3.003987247746e-03 ||r(i)||/||b|| 1.008094842618e+00 > 26 KSP preconditioned resid norm 1.482994894928e+08 true resid norm 3.004024810257e-03 ||r(i)||/||b|| 1.008107448056e+00 > 27 KSP preconditioned resid norm 1.293588493466e+08 true resid norm 3.005576275194e-03 ||r(i)||/||b|| 1.008628097337e+00 > 28 KSP preconditioned resid norm 1.082178475680e+08 true resid norm 3.010519288328e-03 ||r(i)||/||b|| 1.010286901332e+00 > 0 KSP preconditioned resid norm 4.688654651573e+20 true resid norm 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 4.673814485341e+20 true resid norm 3.182057223735e+03 ||r(i)||/||b|| 1.000017504878e+00 > 2 KSP preconditioned resid norm 1.203925723825e+19 true resid norm 3.185040065807e+03 ||r(i)||/||b|| 1.000954915514e+00 > 3 KSP preconditioned resid norm 3.042270671882e+18 true resid norm 3.187076078024e+03 ||r(i)||/||b|| 1.001594768198e+00 > 4 KSP preconditioned resid norm 5.678481873896e+17 true resid norm 3.187261697361e+03 ||r(i)||/||b|| 1.001653102343e+00 > 5 KSP preconditioned resid norm 4.462228267454e+17 true resid norm 3.187264158420e+03 ||r(i)||/||b|| 1.001653875774e+00 > 6 KSP preconditioned resid norm 9.314909592131e+16 true resid norm 3.187268102332e+03 ||r(i)||/||b|| 1.001655115218e+00 > 7 KSP preconditioned resid norm 8.843621410196e+15 true resid norm 3.187268285359e+03 ||r(i)||/||b|| 1.001655172737e+00 > 8 KSP preconditioned resid norm 8.214565462317e+15 true resid norm 3.187268286281e+03 ||r(i)||/||b|| 1.001655173027e+00 > 9 KSP preconditioned resid norm 4.525549868436e+14 true resid norm 3.187268287235e+03 ||r(i)||/||b|| 1.001655173327e+00 > 10 KSP preconditioned resid norm 4.522301211733e+14 true resid norm 3.187268289937e+03 ||r(i)||/||b|| 1.001655174176e+00 > 11 KSP preconditioned resid norm 4.295952793336e+14 true resid norm 3.187268328860e+03 ||r(i)||/||b|| 1.001655186408e+00 > 12 KSP preconditioned resid norm 4.294637249487e+14 true resid norm 3.187268422725e+03 ||r(i)||/||b|| 1.001655215907e+00 > 13 KSP preconditioned resid norm 4.285778654372e+14 true resid norm 3.187269536466e+03 ||r(i)||/||b|| 1.001655565920e+00 > 14 KSP preconditioned resid norm 4.162983479677e+14 true resid norm 3.187285280554e+03 ||r(i)||/||b|| 1.001660513777e+00 > 15 KSP preconditioned resid norm 4.162978556133e+14 true resid norm 3.187285288668e+03 ||r(i)||/||b|| 1.001660516326e+00 > 16 KSP preconditioned resid norm 4.161875124570e+14 true resid norm 3.187285309889e+03 ||r(i)||/||b|| 1.001660522996e+00 > 17 KSP preconditioned resid norm 4.117671313790e+14 true resid norm 3.187289951588e+03 ||r(i)||/||b|| 1.001661981731e+00 > 18 KSP preconditioned resid norm 4.103112320458e+14 true resid norm 3.187292327095e+03 ||r(i)||/||b|| 1.001662728276e+00 > 19 KSP preconditioned resid norm 4.032611123108e+14 true resid norm 3.187463967167e+03 ||r(i)||/||b|| 1.001716669191e+00 > 20 KSP preconditioned resid norm 3.432105733172e+14 true resid norm 3.189686334937e+03 ||r(i)||/||b|| 1.002415087389e+00 > 21 KSP preconditioned resid norm 3.125440416815e+14 true resid norm 3.191137543657e+03 ||r(i)||/||b|| 1.002871155278e+00 > 22 KSP preconditioned resid norm 2.214281952780e+14 true resid norm 3.198766855775e+03 ||r(i)||/||b|| 1.005268800931e+00 > 23 KSP preconditioned resid norm 2.205574806871e+14 true resid norm 3.198012835064e+03 ||r(i)||/||b|| 1.005031836647e+00 > 24 KSP preconditioned resid norm 2.202202974538e+14 true resid norm 3.197792157500e+03 ||r(i)||/||b|| 1.004962484838e+00 > 25 KSP preconditioned resid norm 2.188941573096e+14 true resid norm 3.197631986560e+03 ||r(i)||/||b|| 1.004912148300e+00 > 26 KSP preconditioned resid norm 1.811445509155e+14 true resid norm 3.201511171410e+03 ||r(i)||/||b|| 1.006131250435e+00 > 27 KSP preconditioned resid norm 1.333006235872e+14 true resid norm 3.207865456494e+03 ||r(i)||/||b|| 1.008128196394e+00 > 28 KSP preconditioned resid norm 1.290269724722e+14 true resid norm 3.209026547700e+03 ||r(i)||/||b|| 1.008493089747e+00 > 29 KSP preconditioned resid norm 8.645848930695e+13 true resid norm 3.216715733004e+03 ||r(i)||/||b|| 1.010909551603e+00 > 30 KSP preconditioned resid norm 7.051095175336e+13 true resid norm 3.219405322929e+03 ||r(i)||/||b|| 1.011754802589e+00 > 0 KSP preconditioned resid norm 4.970534641714e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 9.825390294838e+01 true resid norm 6.304087699909e+03 ||r(i)||/||b|| 3.354169267824e+01 > 2 KSP preconditioned resid norm 1.317425630977e+01 true resid norm 1.659038483292e+03 ||r(i)||/||b|| 8.827123224947e+00 > 3 KSP preconditioned resid norm 1.267331175258e+00 true resid norm 3.723773819327e+02 ||r(i)||/||b|| 1.981280765700e+00 > 4 KSP preconditioned resid norm 1.451198865319e-01 true resid norm 6.113281457366e+01 ||r(i)||/||b|| 3.252648403059e-01 > 5 KSP preconditioned resid norm 2.428012832580e-02 true resid norm 9.525516489005e+00 ||r(i)||/||b|| 5.068171032587e-02 > 6 KSP preconditioned resid norm 3.273131599046e-03 true resid norm 1.693121214500e+00 ||r(i)||/||b|| 9.008464689439e-03 > 7 KSP preconditioned resid norm 3.629020564958e-04 true resid norm 1.937921370699e-01 ||r(i)||/||b|| 1.031095475584e-03 > 8 KSP preconditioned resid norm 4.303742583350e-05 true resid norm 2.733022203972e-02 ||r(i)||/||b|| 1.454138889117e-04 > > -pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true -pc_gamg_square_graph 20 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 -ksp_max_it 30 -ksp_monitor_true_residual > > 0 KSP preconditioned resid norm 3.031864566839e+14 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.212883161649e+14 true resid norm 2.982229202367e-03 ||r(i)||/||b|| 1.000793156052e+00 > 2 KSP preconditioned resid norm 5.312941731712e+12 true resid norm 2.985627671175e-03 ||r(i)||/||b|| 1.001933633223e+00 > 3 KSP preconditioned resid norm 3.602406845592e+12 true resid norm 2.985818915765e-03 ||r(i)||/||b|| 1.001997812152e+00 > 4 KSP preconditioned resid norm 6.891073564923e+10 true resid norm 2.986120881484e-03 ||r(i)||/||b|| 1.002099147497e+00 > 5 KSP preconditioned resid norm 1.267096776171e+09 true resid norm 2.986121018547e-03 ||r(i)||/||b|| 1.002099193494e+00 > 6 KSP preconditioned resid norm 5.130735430694e+08 true resid norm 2.986121020564e-03 ||r(i)||/||b|| 1.002099194170e+00 > 7 KSP preconditioned resid norm 5.122457469991e+08 true resid norm 2.986121025937e-03 ||r(i)||/||b|| 1.002099195974e+00 > 8 KSP preconditioned resid norm 5.115042446514e+08 true resid norm 2.986121044146e-03 ||r(i)||/||b|| 1.002099202084e+00 > 9 KSP preconditioned resid norm 5.103842476065e+08 true resid norm 2.986121084005e-03 ||r(i)||/||b|| 1.002099215460e+00 > 10 KSP preconditioned resid norm 5.103414725629e+08 true resid norm 2.986121151167e-03 ||r(i)||/||b|| 1.002099237999e+00 > 11 KSP preconditioned resid norm 5.103050707318e+08 true resid norm 2.986121488999e-03 ||r(i)||/||b|| 1.002099351370e+00 > 12 KSP preconditioned resid norm 5.101511376685e+08 true resid norm 2.986123179301e-03 ||r(i)||/||b|| 1.002099918611e+00 > 13 KSP preconditioned resid norm 5.101218154297e+08 true resid norm 2.986123839891e-03 ||r(i)||/||b|| 1.002100140296e+00 > 14 KSP preconditioned resid norm 5.095285470767e+08 true resid norm 2.986138347067e-03 ||r(i)||/||b|| 1.002105008695e+00 > 15 KSP preconditioned resid norm 5.082373114330e+08 true resid norm 2.986170368742e-03 ||r(i)||/||b|| 1.002115754708e+00 > 16 KSP preconditioned resid norm 5.079055966450e+08 true resid norm 2.986178765357e-03 ||r(i)||/||b|| 1.002118572491e+00 > 17 KSP preconditioned resid norm 4.278159855635e+08 true resid norm 2.989173921061e-03 ||r(i)||/||b|| 1.003123703595e+00 > 18 KSP preconditioned resid norm 3.704767561598e+08 true resid norm 2.991993992919e-03 ||r(i)||/||b|| 1.004070079082e+00 > 19 KSP preconditioned resid norm 3.690160215681e+08 true resid norm 2.992090282533e-03 ||r(i)||/||b|| 1.004102392489e+00 > 20 KSP preconditioned resid norm 3.135406273863e+08 true resid norm 2.996344554486e-03 ||r(i)||/||b|| 1.005530064867e+00 > 21 KSP preconditioned resid norm 1.938459923255e+08 true resid norm 3.005844334042e-03 ||r(i)||/||b|| 1.008718054025e+00 > 22 KSP preconditioned resid norm 1.827826394560e+08 true resid norm 3.007605246670e-03 ||r(i)||/||b|| 1.009308990933e+00 > 23 KSP preconditioned resid norm 1.108660460314e+08 true resid norm 3.020965814060e-03 ||r(i)||/||b|| 1.013792604867e+00 > 24 KSP preconditioned resid norm 1.051235646374e+08 true resid norm 3.021541389078e-03 ||r(i)||/||b|| 1.013985759551e+00 > 25 KSP preconditioned resid norm 7.173044522784e+07 true resid norm 3.024254088703e-03 ||r(i)||/||b|| 1.014896102464e+00 > 26 KSP preconditioned resid norm 6.350860057272e+07 true resid norm 3.023434854983e-03 ||r(i)||/||b|| 1.014621179430e+00 > 27 KSP preconditioned resid norm 5.267152287984e+07 true resid norm 3.022203752421e-03 ||r(i)||/||b|| 1.014208039146e+00 > 28 KSP preconditioned resid norm 4.650599761568e+07 true resid norm 3.022093139351e-03 ||r(i)||/||b|| 1.014170918994e+00 > 29 KSP preconditioned resid norm 3.141941642480e+07 true resid norm 3.023444082486e-03 ||r(i)||/||b|| 1.014624276047e+00 > 30 KSP preconditioned resid norm 2.065598123858e+07 true resid norm 3.024498453617e-03 ||r(i)||/||b|| 1.014978107808e+00 > 0 KSP preconditioned resid norm 4.257133849062e+20 true resid norm 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.793742274994e+19 true resid norm 3.184922256681e+03 ||r(i)||/||b|| 1.000917891922e+00 > 2 KSP preconditioned resid norm 1.137325629643e+19 true resid norm 3.185147137826e+03 ||r(i)||/||b|| 1.000988564781e+00 > 3 KSP preconditioned resid norm 7.164960007703e+18 true resid norm 3.186117509159e+03 ||r(i)||/||b|| 1.001293521056e+00 > 4 KSP preconditioned resid norm 1.109461464210e+17 true resid norm 3.187268097356e+03 ||r(i)||/||b|| 1.001655113654e+00 > 5 KSP preconditioned resid norm 1.984768045830e+15 true resid norm 3.187268427639e+03 ||r(i)||/||b|| 1.001655217451e+00 > 6 KSP preconditioned resid norm 7.354105789290e+14 true resid norm 3.187268429720e+03 ||r(i)||/||b|| 1.001655218105e+00 > 7 KSP preconditioned resid norm 6.662738391887e+14 true resid norm 3.187268442496e+03 ||r(i)||/||b|| 1.001655222120e+00 > 8 KSP preconditioned resid norm 5.358556594776e+14 true resid norm 3.187268479547e+03 ||r(i)||/||b|| 1.001655233764e+00 > 9 KSP preconditioned resid norm 5.055368509046e+14 true resid norm 3.187268491131e+03 ||r(i)||/||b|| 1.001655237405e+00 > 10 KSP preconditioned resid norm 5.050370080533e+14 true resid norm 3.187268557074e+03 ||r(i)||/||b|| 1.001655258129e+00 > 11 KSP preconditioned resid norm 5.049526065770e+14 true resid norm 3.187269209319e+03 ||r(i)||/||b|| 1.001655463108e+00 > 12 KSP preconditioned resid norm 5.048442087580e+14 true resid norm 3.187270145328e+03 ||r(i)||/||b|| 1.001655757265e+00 > 13 KSP preconditioned resid norm 5.048317293084e+14 true resid norm 3.187270420057e+03 ||r(i)||/||b|| 1.001655843604e+00 > 14 KSP preconditioned resid norm 5.046339848740e+14 true resid norm 3.187276012517e+03 ||r(i)||/||b|| 1.001657601133e+00 > 15 KSP preconditioned resid norm 5.036574780195e+14 true resid norm 3.187304228896e+03 ||r(i)||/||b|| 1.001666468627e+00 > 16 KSP preconditioned resid norm 5.033948448037e+14 true resid norm 3.187311929535e+03 ||r(i)||/||b|| 1.001668888688e+00 > 17 KSP preconditioned resid norm 4.374073117273e+14 true resid norm 3.190248474209e+03 ||r(i)||/||b|| 1.002591749552e+00 > 18 KSP preconditioned resid norm 3.454318321770e+14 true resid norm 3.195991944291e+03 ||r(i)||/||b|| 1.004396736143e+00 > 19 KSP preconditioned resid norm 3.438483821871e+14 true resid norm 3.196113376292e+03 ||r(i)||/||b|| 1.004434898287e+00 > 20 KSP preconditioned resid norm 3.090011643835e+14 true resid norm 3.199125186774e+03 ||r(i)||/||b|| 1.005381412756e+00 > 21 KSP preconditioned resid norm 1.976112359751e+14 true resid norm 3.209202875553e+03 ||r(i)||/||b|| 1.008548503879e+00 > 22 KSP preconditioned resid norm 1.874048396302e+14 true resid norm 3.210733816807e+03 ||r(i)||/||b|| 1.009029629122e+00 > 23 KSP preconditioned resid norm 1.086663247242e+14 true resid norm 3.224219602770e+03 ||r(i)||/||b|| 1.013267774787e+00 > 24 KSP preconditioned resid norm 1.036005882413e+14 true resid norm 3.224749127723e+03 ||r(i)||/||b|| 1.013434187326e+00 > 25 KSP preconditioned resid norm 6.943244220256e+13 true resid norm 3.227732423395e+03 ||r(i)||/||b|| 1.014371740514e+00 > 26 KSP preconditioned resid norm 6.064453821356e+13 true resid norm 3.227303114420e+03 ||r(i)||/||b|| 1.014236822611e+00 > 27 KSP preconditioned resid norm 5.237876331038e+13 true resid norm 3.226320811775e+03 ||r(i)||/||b|| 1.013928116710e+00 > 28 KSP preconditioned resid norm 4.407157490353e+13 true resid norm 3.226123552298e+03 ||r(i)||/||b|| 1.013866124447e+00 > 29 KSP preconditioned resid norm 3.691867703712e+13 true resid norm 3.226578266524e+03 ||r(i)||/||b|| 1.014009026398e+00 > 0 KSP preconditioned resid norm 4.105203293801e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.404700393158e+02 true resid norm 5.941722233814e+03 ||r(i)||/||b|| 3.161368157187e+01 > 2 KSP preconditioned resid norm 3.849004101235e+01 true resid norm 3.456178528017e+03 ||r(i)||/||b|| 1.838903320294e+01 > 3 KSP preconditioned resid norm 8.384263059954e+00 true resid norm 1.401839902990e+03 ||r(i)||/||b|| 7.458665781386e+00 > 4 KSP preconditioned resid norm 1.363029002549e+00 true resid norm 3.612540200618e+02 ||r(i)||/||b|| 1.922097517753e+00 > 5 KSP preconditioned resid norm 3.734525206097e-01 true resid norm 1.272038960182e+02 ||r(i)||/||b|| 6.768043515285e-01 > 6 KSP preconditioned resid norm 8.146021124788e-02 true resid norm 3.196642795661e+01 ||r(i)||/||b|| 1.700814064749e-01 > 7 KSP preconditioned resid norm 2.110568459516e-02 true resid norm 6.793208791728e+00 ||r(i)||/||b|| 3.614412305757e-02 > 8 KSP preconditioned resid norm 4.044708317961e-03 true resid norm 1.976363197299e+00 ||r(i)||/||b|| 1.051548933644e-02 > 9 KSP preconditioned resid norm 9.154675861687e-04 true resid norm 3.458820713849e-01 ||r(i)||/||b|| 1.840309128547e-03 > 10 KSP preconditioned resid norm 2.106487039520e-04 true resid norm 1.064965566696e-01 ||r(i)||/||b|| 5.666283442018e-04 > 11 KSP preconditioned resid norm 5.145654020522e-05 true resid norm 2.436255895394e-02 ||r(i)||/||b|| 1.296240636532e-04 > 12 KSP preconditioned resid norm 1.223910887488e-05 true resid norm 4.954689842368e-03 ||r(i)||/||b|| 2.636205140533e-05 > >> Il giorno 01 ago 2018, alle ore 15:41, Matthew Knepley > ha scritto: >> >> On Wed, Aug 1, 2018 at 9:02 AM Pierpaolo Minelli > wrote: >>> Il giorno 27 lug 2018, alle ore 18:32, Smith, Barry F. > ha scritto: >>> >>>> On Jul 27, 2018, at 3:26 AM, Pierpaolo Minelli > wrote: >>>> >>>> >>>> Finally, I have a question. In my simulation I solve the two systems at each step of the calculation, and it was my habit to use the following option after the first resolution and before solving the system in the second time step: >>>> >>>> call KSPSetInitialGuessNonzero(ksp,PETSC_TRUE,ierr) >>>> >>>> Since this option was incompatible with the use of MUMPS or SuperLU_Dist, I commented on it and noticed, to my surprise, that iterative methods were not affected by this comment, rather they were slightly faster. Is this normal? Or do I use this command incorrectly? >>> >>> Presuming this is a linear problem? >>> >>> You should run with -ksp_monitor_true_residual and compare the final residual norms (at linear system convergence). Since KSP uses a relative decrease in the residual norm to declare convergence what you have told us isn't enough to determine if one is converging "faster" to the solution then the other. >>> >>> Barry >> >> Yes, there are two linear problems. The first in the field of complex numbers (which I divided into two problems in the field of real numbers as suggested by Matthew) and the second in the field of real numbers. >> >> These are the results obtained using the option -ksp_monitor_true_residual: >> >> -pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 -ksp_monitor_true_residual >> >> 0 KSP preconditioned resid norm 1.324344286254e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 3.399266083153e-03 true resid norm 1.196951495628e+05 ||r(i)||/||b|| 4.016796777391e+07 >> 2 KSP preconditioned resid norm 6.287919852336e-04 true resid norm 4.429876706490e+04 ||r(i)||/||b|| 1.486602802524e+07 >> 3 KSP preconditioned resid norm 8.836547690039e-05 true resid norm 1.182383826632e+04 ||r(i)||/||b|| 3.967909778970e+06 >> 4 KSP preconditioned resid norm 1.291370058561e-05 true resid norm 2.801893692950e+03 ||r(i)||/||b|| 9.402751571421e+05 >> 5 KSP preconditioned resid norm 2.073922228951e-06 true resid norm 6.312112895919e+02 ||r(i)||/||b|| 2.118254150770e+05 >> 6 KSP preconditioned resid norm 3.283811876800e-07 true resid norm 8.777865833701e+01 ||r(i)||/||b|| 2.945725313178e+04 >> 7 KSP preconditioned resid norm 5.414680273500e-08 true resid norm 1.610127004050e+01 ||r(i)||/||b|| 5.403354258448e+03 >> 8 KSP preconditioned resid norm 9.645834363683e-09 true resid norm 3.006444251909e+00 ||r(i)||/||b|| 1.008919377818e+03 >> 9 KSP preconditioned resid norm 1.915420455785e-09 true resid norm 6.672996533262e-01 ||r(i)||/||b|| 2.239361500298e+02 >> 10 KSP preconditioned resid norm 3.334928638696e-10 true resid norm 1.185976397497e-01 ||r(i)||/||b|| 3.979965929219e+01 >> >> You can see from the "true resid norm" that your complex problem is not actually being solved. ML and Hypre have similar results. >> I would guess that your coarse grid is near singular. >> >> The real problem is being solved correctly, although you are still 100x off the true residual so the preconditioner is not great. >> Have you tested with a manufactured solution? >> >> Thanks, >> >> Matt > > > > > > > >> >> 0 KSP preconditioned resid norm 1.416256896904e+04 true resid norm 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 3.781264980774e+03 true resid norm 1.283809201228e+11 ||r(i)||/||b|| 1.938227104995e+05 >> 2 KSP preconditioned resid norm 7.392413714593e+02 true resid norm 4.990467508600e+10 ||r(i)||/||b|| 7.534343407504e+04 >> 3 KSP preconditioned resid norm 1.087641767696e+02 true resid norm 1.367263690390e+10 ||r(i)||/||b|| 2.064222270610e+04 >> 4 KSP preconditioned resid norm 1.627726591174e+01 true resid norm 3.451534923895e+09 ||r(i)||/||b|| 5.210944536719e+03 >> 5 KSP preconditioned resid norm 2.564636460142e+00 true resid norm 7.980525032990e+08 ||r(i)||/||b|| 1.204857381941e+03 >> 6 KSP preconditioned resid norm 4.252626820180e-01 true resid norm 1.151817528111e+08 ||r(i)||/||b|| 1.738953070953e+02 >> 7 KSP preconditioned resid norm 6.758292325957e-02 true resid norm 2.065701091779e+07 ||r(i)||/||b|| 3.118686050134e+01 >> 8 KSP preconditioned resid norm 1.099617201063e-02 true resid norm 3.470561062696e+06 ||r(i)||/||b|| 5.239669192917e+00 >> 9 KSP preconditioned resid norm 2.195352537111e-03 true resid norm 7.056823048483e+05 ||r(i)||/||b|| 1.065401750871e+00 >> 10 KSP preconditioned resid norm 4.380752631896e-04 true resid norm 1.440377395627e+05 ||r(i)||/||b|| 2.174605468598e-01 >> >> 0 KSP preconditioned resid norm 4.970534641714e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 9.825390294838e+01 true resid norm 6.304087699909e+03 ||r(i)||/||b|| 3.354169267824e+01 >> 2 KSP preconditioned resid norm 1.317425630977e+01 true resid norm 1.659038483292e+03 ||r(i)||/||b|| 8.827123224947e+00 >> 3 KSP preconditioned resid norm 1.267331175258e+00 true resid norm 3.723773819327e+02 ||r(i)||/||b|| 1.981280765700e+00 >> 4 KSP preconditioned resid norm 1.451198865319e-01 true resid norm 6.113281457366e+01 ||r(i)||/||b|| 3.252648403059e-01 >> 5 KSP preconditioned resid norm 2.428012832580e-02 true resid norm 9.525516489005e+00 ||r(i)||/||b|| 5.068171032587e-02 >> 6 KSP preconditioned resid norm 3.273131599046e-03 true resid norm 1.693121214500e+00 ||r(i)||/||b|| 9.008464689439e-03 >> 7 KSP preconditioned resid norm 3.629020564958e-04 true resid norm 1.937921370699e-01 ||r(i)||/||b|| 1.031095475584e-03 >> 8 KSP preconditioned resid norm 4.303742583350e-05 true resid norm 2.733022203972e-02 ||r(i)||/||b|| 1.454138889117e-04 >> >> -pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual >> >> 0 KSP preconditioned resid norm 1.825767020537e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 6.495628259378e-04 true resid norm 1.373525306349e+04 ||r(i)||/||b|| 4.609353047603e+06 >> 2 KSP preconditioned resid norm 4.971875712010e-05 true resid norm 2.154150315236e+03 ||r(i)||/||b|| 7.229018114651e+05 >> 3 KSP preconditioned resid norm 3.726806462903e-06 true resid norm 3.000693510070e+02 ||r(i)||/||b|| 1.006989511706e+05 >> 4 KSP preconditioned resid norm 2.496898447113e-07 true resid norm 3.004338446358e+01 ||r(i)||/||b|| 1.008212699813e+04 >> 5 KSP preconditioned resid norm 1.541814409235e-08 true resid norm 2.256927674575e+00 ||r(i)||/||b|| 7.573924125705e+02 >> 6 KSP preconditioned resid norm 1.153890845088e-09 true resid norm 2.007294077611e-01 ||r(i)||/||b|| 6.736189738408e+01 >> 0 KSP preconditioned resid norm 1.961448048638e+04 true resid norm 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 7.940694187362e+02 true resid norm 1.483756468402e+10 ||r(i)||/||b|| 2.240096894085e+04 >> 2 KSP preconditioned resid norm 6.141876183549e+01 true resid norm 2.581042149104e+09 ||r(i)||/||b|| 3.896720671376e+03 >> 3 KSP preconditioned resid norm 4.872887149903e+00 true resid norm 3.544664743366e+08 ||r(i)||/||b|| 5.351547003355e+02 >> 4 KSP preconditioned resid norm 3.088357668912e-01 true resid norm 3.689655474675e+07 ||r(i)||/||b|| 5.570446326655e+01 >> 5 KSP preconditioned resid norm 2.030016543101e-02 true resid norm 2.847019997470e+06 ||r(i)||/||b|| 4.298279933093e+00 >> 6 KSP preconditioned resid norm 1.458276940703e-03 true resid norm 2.567051860886e+05 ||r(i)||/||b|| 3.875598875547e-01 >> >> 0 KSP preconditioned resid norm 6.230592591466e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 3.825349376322e+01 true resid norm 7.755266613308e+02 ||r(i)||/||b|| 4.126287287931e+00 >> 2 KSP preconditioned resid norm 4.321561767174e+00 true resid norm 2.170558998883e+02 ||r(i)||/||b|| 1.154873255992e+00 >> 3 KSP preconditioned resid norm 2.806349660119e-01 true resid norm 2.931496742303e+01 ||r(i)||/||b|| 1.559739767247e-01 >> 4 KSP preconditioned resid norm 1.707567397460e-02 true resid norm 2.684913551118e+00 ||r(i)||/||b|| 1.428542074383e-02 >> 5 KSP preconditioned resid norm 1.741069717192e-03 true resid norm 2.914639372698e-01 ||r(i)||/||b|| 1.550770591410e-03 >> 6 KSP preconditioned resid norm 1.460913620440e-04 true resid norm 3.460791330512e-02 ||r(i)||/||b|| 1.841357619965e-04 >> 7 KSP preconditioned resid norm 1.741167177387e-05 true resid norm 3.396573365236e-03 ||r(i)||/||b|| 1.807189642642e-05 >> >> -pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual >> >> 0 KSP preconditioned resid norm 1.984853668903e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 1.924446712660e-04 true resid norm 8.461145171168e+03 ||r(i)||/||b|| 2.839438421750e+06 >> 2 KSP preconditioned resid norm 5.161509100761e-06 true resid norm 4.501007519328e+02 ||r(i)||/||b|| 1.510473278548e+05 >> 3 KSP preconditioned resid norm 9.297326931235e-08 true resid norm 1.474595580807e+01 ||r(i)||/||b|| 4.948530327732e+03 >> 4 KSP preconditioned resid norm 1.910271882618e-09 true resid norm 3.603243780988e-01 ||r(i)||/||b|| 1.209196701829e+02 >> 0 KSP preconditioned resid norm 2.157687745804e+04 true resid norm 6.623626291881e+05 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 1.949268476385e+02 true resid norm 8.974916757495e+09 ||r(i)||/||b|| 1.354985375382e+04 >> 2 KSP preconditioned resid norm 5.078054475786e+00 true resid norm 4.502684440161e+08 ||r(i)||/||b|| 6.797914377626e+02 >> 3 KSP preconditioned resid norm 8.663802743525e-02 true resid norm 1.432117031381e+07 ||r(i)||/||b|| 2.162134408362e+01 >> 4 KSP preconditioned resid norm 1.795605563041e-03 true resid norm 3.389868548833e+05 ||r(i)||/||b|| 5.117843911255e-01 >> >> 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 >> 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 >> 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 >> 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 >> 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 >> >> Thanks >> >> Pierpaolo >> >>>> >>>> Thanks >>>> >>>> Pierpaolo >>>> >>>>> Il giorno 23 lug 2018, alle ore 15:43, Mark Adams > ha scritto: >>>>> >>>>> Note, as Barry said, GAMG works with native complex numbers. You can start with your original complex build and use '-pc_type gamg'. >>>>> Mark >>>>> >>>>> On Mon, Jul 23, 2018 at 6:52 AM Pierpaolo Minelli > wrote: >>>>> >>>>> >>>>>> Il giorno 20 lug 2018, alle ore 19:58, Smith, Barry F. > ha scritto: >>>>>> >>>>>> >>>>>> >>>>>>> On Jul 20, 2018, at 7:01 AM, Pierpaolo Minelli > wrote: >>>>>>> >>>>>>> Hi, >>>>>>> >>>>>>> in my code I have to solve both a system in the field of real numbers and in the field of complex numbers. >>>>>>> My approach has been as follows. >>>>>>> First I configured PETSc with the --with-scalar-type=complex option. >>>>>>> Using this option I have unfortunately lost the possibility to use the two preconditioners ML and Hypre. >>>>>> >>>>>> You should still be able to use the PETSc PCGAMG algebraic multigrid solver. Have you tried that? If there are issues let us know because we would like to continue to improve the performance of PCGAMG to get it to be closer to as good as ML and hypre. >>>>>> >>>>>> Barry >>>>>> >>>>> >>>>> I will try to convert, as suggested by Matthew, my complex system in a system twice as large in real numbers. When i finish, i will try to use ML, Hypre and GAMG and i let you know if there are any performance differences. >>>>> >>>>> Thanks >>>>> >>>>> Pierpaolo >>>>> >>>>> >>>>>>> I later created two subspaces of Krylov and tried to solve the two systems as I used to when solving the only equation in the real numbers field. >>>>>>> In order to correctly solve the system in the field of real numbers I had to transform the coefficients from real to complex with an imaginary part equal to zero. >>>>>>> >>>>>>> Is there a possibility to use a different and better approach to solve my problem? >>>>>>> >>>>>>> Perhaps an approach where you can continue to use ML and Hypre for system solving in the real numbers field or where you don't need to use complex numbers when real numbers would actually suffice? >>>>>>> >>>>>>> Thanks in advance >>>>>>> >>>>>>> Pierpaolo >>>>>>> >>>>>> >>>>> >>>> >>> >> >> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: clip_image002.png Type: image/png Size: 2782 bytes Desc: not available URL: From mfadams at lbl.gov Fri Aug 3 08:16:02 2018 From: mfadams at lbl.gov (Mark Adams) Date: Fri, 3 Aug 2018 08:16:02 -0500 Subject: [petsc-users] Solving Linear Systems with Scalar Real and Complex In-Reply-To: References: <405250E7-D339-4F7A-BD0D-B008D6B3FC8D@cnr.it> <3B4B622A-EBCE-4E61-9039-CA8C34F730A4@cnr.it> <0ECD0720-31CA-443F-A44C-6703063B26B5@anl.gov> <583A6898-B577-495D-96C9-FFABA14B5B8D@cnr.it> Message-ID: So this is a complex valued indefinite Helmholtz operator (very hard to solve scalably) with axisymmetric coordinates. ML, hypre and GAMG all performed about the same, with a big jump in residual initially and essentially not solving it. You scaled it and this fixed ML and hypre but not GAMG. >From this output I can see that the eigenvalue estimates are strange. Your equations look fine so I have to assume that the complex values are the problem. If this is symmetric the CG is a much better solver and eigen estimator. But this is not a big deal, especially since you have two options that work. I would suggest not using cheby smoother, it uses these bad eigen estimates, and it is basically not smoothing on some levels. You can use this instead: -mg_levels_ksp_type richardson -mg_levels_pc_type sor Note, if you have a large shift these equations are very hard to solve iteratively and you should just use a direct solver. Direct solvers in 2D are not bad, Mark On Fri, Aug 3, 2018 at 3:02 AM Pierpaolo Minelli wrote: > In this simulation I'm solving two equations in a two-dimensional domain > (z,r) at each time step. The first is an equation derived from the Maxwell > equation. Taking advantage of the fact that the domain is axialsymmetric > and applying a temporal harmonic approximation, the equation I am solving > is the following: > > > The second equation is a Poisson?s equation in cylindrical coordinates > (z,r) in the field of real numbers. > > This is the output obtained using these options (Note that at this moment > of development I am only using a processor): > > *-pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true > -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 > -ksp_max_it 30 -ksp_monitor_true_residual -info | grep GAMG* > > [0] PCSetUp_GAMG(): level 0) N=321201, n data rows=1, n data cols=1, > nnz/row (ave)=5, np=1 > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 4.97011 nnz ave. (N=321201) > [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square > [0] PCGAMGProlongator_AGG(): New grid 45754 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.972526e+00 > min=3.461411e-03 PC=jacobi > [0] PCSetUp_GAMG(): 1) N=45754, n data cols=1, nnz/row (ave)=10, 1 active > pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 10.7695 nnz ave. (N=45754) > [0] PCGAMGProlongator_AGG(): New grid 7893 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=5.686837e+00 > min=5.062501e-01 PC=jacobi > [0] PCSetUp_GAMG(): 2) N=7893, n data cols=1, nnz/row (ave)=23, 1 active > pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 23.2179 nnz ave. (N=7893) > [0] PCGAMGProlongator_AGG(): New grid 752 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.504451e+01 > min=2.124898e-02 PC=jacobi > [0] PCSetUp_GAMG(): 3) N=752, n data cols=1, nnz/row (ave)=30, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 30.7367 nnz ave. (N=752) > [0] PCGAMGProlongator_AGG(): New grid 56 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=7.781296e+00 > min=2.212257e-02 PC=jacobi > [0] PCSetUp_GAMG(): 4) N=56, n data cols=1, nnz/row (ave)=22, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 22.9643 nnz ave. (N=56) > [0] PCGAMGProlongator_AGG(): New grid 6 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.525086e+00 > min=1.375043e-01 PC=jacobi > [0] PCSetUp_GAMG(): 5) N=6, n data cols=1, nnz/row (ave)=6, 1 active pes > [0] PCSetUp_GAMG(): 6 levels, grid complexity = 1.43876 > [0] PCSetUp_GAMG(): level 0) N=321201, n data rows=1, n data cols=1, > nnz/row (ave)=5, np=1 > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 4.97011 nnz ave. (N=321201) > [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square > [0] PCGAMGProlongator_AGG(): New grid 45754 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.972526e+00 > min=3.461411e-03 PC=jacobi > [0] PCSetUp_GAMG(): 1) N=45754, n data cols=1, nnz/row (ave)=10, 1 active > pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 10.7695 nnz ave. (N=45754) > [0] PCGAMGProlongator_AGG(): New grid 7893 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=5.686837e+00 > min=5.062501e-01 PC=jacobi > [0] PCSetUp_GAMG(): 2) N=7893, n data cols=1, nnz/row (ave)=23, 1 active > pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 23.2179 nnz ave. (N=7893) > [0] PCGAMGProlongator_AGG(): New grid 752 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.504451e+01 > min=2.124898e-02 PC=jacobi > [0] PCSetUp_GAMG(): 3) N=752, n data cols=1, nnz/row (ave)=30, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 30.7367 nnz ave. (N=752) > [0] PCGAMGProlongator_AGG(): New grid 56 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=7.781296e+00 > min=2.212257e-02 PC=jacobi > [0] PCSetUp_GAMG(): 4) N=56, n data cols=1, nnz/row (ave)=22, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 22.9643 nnz ave. (N=56) > [0] PCGAMGProlongator_AGG(): New grid 6 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.525086e+00 > min=1.375043e-01 PC=jacobi > [0] PCSetUp_GAMG(): 5) N=6, n data cols=1, nnz/row (ave)=6, 1 active pes > [0] PCSetUp_GAMG(): 6 levels, grid complexity = 1.43876 > [0] PCSetUp_GAMG(): level 0) N=271201, n data rows=1, n data cols=1, > nnz/row (ave)=5, np=1 > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 4.97455 nnz ave. (N=271201) > [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square > [0] PCGAMGProlongator_AGG(): New grid 38501 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.933798e+00 > min=4.684075e-02 PC=jacobi > [0] PCSetUp_GAMG(): 1) N=38501, n data cols=1, nnz/row (ave)=10, 1 active > pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 10.7732 nnz ave. (N=38501) > [0] PCGAMGProlongator_AGG(): New grid 6664 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.623029e+00 > min=1.250957e-02 PC=jacobi > [0] PCSetUp_GAMG(): 2) N=6664, n data cols=1, nnz/row (ave)=23, 1 active > pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 23.2098 nnz ave. (N=6664) > [0] PCGAMGProlongator_AGG(): New grid 620 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.763329e+00 > min=1.611776e-02 PC=jacobi > [0] PCSetUp_GAMG(): 3) N=620, n data cols=1, nnz/row (ave)=29, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., > 29.6129 nnz ave. (N=620) > [0] PCGAMGProlongator_AGG(): New grid 46 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.497611e+00 > min=2.630403e-02 PC=jacobi > [0] PCSetUp_GAMG(): 4) N=46, n data cols=1, nnz/row (ave)=20, 1 active pes > [0] PCSetUp_GAMG(): 5 levels, grid complexity = 1.43639 > > > > > Il giorno 02 ago 2018, alle ore 17:39, Mark Adams ha > scritto: > > It looks like ML and hypre are working well now. If you want to debug GAMG > you can run with -info, which is very noisy, and grep on GAMG or send the > whole output. > > BTW, what equations are you solving? > > On Thu, Aug 2, 2018 at 5:12 AM Pierpaolo Minelli > wrote: > >> Thank you very much for the correction. >> By rebalancing the matrix coefficients, making them dimensionless, in my >> complex problem i managed to obtain a better result with both ML and HYPRE. >> GAMG instead seems to be unable to converge and in fact I get unexpected >> results. I report the outputs of the three simulations again (i tried to >> use also -pc_gamg_square_graph 20 without any improvement). >> >> Pierpaolo >> >> *-pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual* >> >> 0 KSP preconditioned resid norm 1.984853668904e-02 true resid norm >> 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 1.924446712661e-04 true resid norm >> 1.204260204811e-04 ||r(i)||/||b|| 4.041323752460e-02 >> 2 KSP preconditioned resid norm 5.161509100765e-06 true resid norm >> 2.810809726926e-06 ||r(i)||/||b|| 9.432672496933e-04 >> 3 KSP preconditioned resid norm 9.297326931238e-08 true resid norm >> 4.474617977876e-08 ||r(i)||/||b|| 1.501617328625e-05 >> 4 KSP preconditioned resid norm 1.910271882670e-09 true resid norm >> 9.637470658283e-10 ||r(i)||/||b|| 3.234196308186e-07 >> 0 KSP preconditioned resid norm 2.157687745805e+04 true resid norm >> 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 1.949268476386e+02 true resid norm >> 1.243419788627e+02 ||r(i)||/||b|| 3.907665598415e-02 >> 2 KSP preconditioned resid norm 5.078054475792e+00 true resid norm >> 2.745355604400e+00 ||r(i)||/||b|| 8.627763325675e-04 >> 3 KSP preconditioned resid norm 8.663802743529e-02 true resid norm >> 4.254290979292e-02 ||r(i)||/||b|| 1.336985839979e-05 >> 4 KSP preconditioned resid norm 1.795605563039e-03 true resid norm >> 9.040507428245e-04 ||r(i)||/||b|| 2.841138623714e-07 >> 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm >> 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm >> 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 >> 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm >> 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 >> 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm >> 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 >> 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm >> 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 >> 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm >> 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 >> >> *-pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual* >> >> 0 KSP preconditioned resid norm 1.825767020538e-02 true resid norm >> 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 6.495628259383e-04 true resid norm >> 3.739440526742e-04 ||r(i)||/||b|| 1.254902367550e-01 >> 2 KSP preconditioned resid norm 4.971875712015e-05 true resid norm >> 2.118856024328e-05 ||r(i)||/||b|| 7.110575559127e-03 >> 3 KSP preconditioned resid norm 3.726806462912e-06 true resid norm >> 1.370355844514e-06 ||r(i)||/||b|| 4.598716790303e-04 >> 4 KSP preconditioned resid norm 2.496898447120e-07 true resid norm >> 9.494701893753 >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: clip_image002.png Type: image/png Size: 2782 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: clip_image002.png Type: image/png Size: 2782 bytes Desc: not available URL: From pierpaolo.minelli at cnr.it Fri Aug 3 08:42:16 2018 From: pierpaolo.minelli at cnr.it (Pierpaolo Minelli) Date: Fri, 3 Aug 2018 15:42:16 +0200 Subject: [petsc-users] Solving Linear Systems with Scalar Real and Complex In-Reply-To: References: <405250E7-D339-4F7A-BD0D-B008D6B3FC8D@cnr.it> <3B4B622A-EBCE-4E61-9039-CA8C34F730A4@cnr.it> <0ECD0720-31CA-443F-A44C-6703063B26B5@anl.gov> <583A6898-B577-495D-96C9-FFABA14B5B8D@cnr.it> Message-ID: <6E8F7E03-DC50-4CBA-AA47-99949B893C9C@cnr.it> I tried to use these options with GAMG: > -mg_levels_ksp_type richardson > -mg_levels_pc_type sor but also in this case i don?t obtain a convergence. I used also direct solvers (MUMPS ad SuperLU) and they works fine, but slower (solve time) then iterative method with ML and hypre. If i check with -ksp_monitor_true_residual, is it advisable to continue using the iterative method? Pierpaolo > Il giorno 03 ago 2018, alle ore 15:16, Mark Adams ha scritto: > > So this is a complex valued indefinite Helmholtz operator (very hard to solve scalably) with axisymmetric coordinates. ML, hypre and GAMG all performed about the same, with a big jump in residual initially and essentially not solving it. You scaled it and this fixed ML and hypre but not GAMG. > > From this output I can see that the eigenvalue estimates are strange. Your equations look fine so I have to assume that the complex values are the problem. If this is symmetric the CG is a much better solver and eigen estimator. But this is not a big deal, especially since you have two options that work. I would suggest not using cheby smoother, it uses these bad eigen estimates, and it is basically not smoothing on some levels. You can use this instead: > > -mg_levels_ksp_type richardson > -mg_levels_pc_type sor > > Note, if you have a large shift these equations are very hard to solve iteratively and you should just use a direct solver. Direct solvers in 2D are not bad, > > Mark > > > On Fri, Aug 3, 2018 at 3:02 AM Pierpaolo Minelli > wrote: > In this simulation I'm solving two equations in a two-dimensional domain (z,r) at each time step. The first is an equation derived from the Maxwell equation. Taking advantage of the fact that the domain is axialsymmetric and applying a temporal harmonic approximation, the equation I am solving is the following: > > > > > The second equation is a Poisson?s equation in cylindrical coordinates (z,r) in the field of real numbers. > > This is the output obtained using these options (Note that at this moment of development I am only using a processor): > > -pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 -ksp_max_it 30 -ksp_monitor_true_residual -info | grep GAMG > > [0] PCSetUp_GAMG(): level 0) N=321201, n data rows=1, n data cols=1, nnz/row (ave)=5, np=1 > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 4.97011 nnz ave. (N=321201) > [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square > [0] PCGAMGProlongator_AGG(): New grid 45754 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.972526e+00 min=3.461411e-03 PC=jacobi > [0] PCSetUp_GAMG(): 1) N=45754, n data cols=1, nnz/row (ave)=10, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 10.7695 nnz ave. (N=45754) > [0] PCGAMGProlongator_AGG(): New grid 7893 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=5.686837e+00 min=5.062501e-01 PC=jacobi > [0] PCSetUp_GAMG(): 2) N=7893, n data cols=1, nnz/row (ave)=23, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 23.2179 nnz ave. (N=7893) > [0] PCGAMGProlongator_AGG(): New grid 752 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.504451e+01 min=2.124898e-02 PC=jacobi > [0] PCSetUp_GAMG(): 3) N=752, n data cols=1, nnz/row (ave)=30, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 30.7367 nnz ave. (N=752) > [0] PCGAMGProlongator_AGG(): New grid 56 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=7.781296e+00 min=2.212257e-02 PC=jacobi > [0] PCSetUp_GAMG(): 4) N=56, n data cols=1, nnz/row (ave)=22, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 22.9643 nnz ave. (N=56) > [0] PCGAMGProlongator_AGG(): New grid 6 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.525086e+00 min=1.375043e-01 PC=jacobi > [0] PCSetUp_GAMG(): 5) N=6, n data cols=1, nnz/row (ave)=6, 1 active pes > [0] PCSetUp_GAMG(): 6 levels, grid complexity = 1.43876 > [0] PCSetUp_GAMG(): level 0) N=321201, n data rows=1, n data cols=1, nnz/row (ave)=5, np=1 > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 4.97011 nnz ave. (N=321201) > [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square > [0] PCGAMGProlongator_AGG(): New grid 45754 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.972526e+00 min=3.461411e-03 PC=jacobi > [0] PCSetUp_GAMG(): 1) N=45754, n data cols=1, nnz/row (ave)=10, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 10.7695 nnz ave. (N=45754) > [0] PCGAMGProlongator_AGG(): New grid 7893 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=5.686837e+00 min=5.062501e-01 PC=jacobi > [0] PCSetUp_GAMG(): 2) N=7893, n data cols=1, nnz/row (ave)=23, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 23.2179 nnz ave. (N=7893) > [0] PCGAMGProlongator_AGG(): New grid 752 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.504451e+01 min=2.124898e-02 PC=jacobi > [0] PCSetUp_GAMG(): 3) N=752, n data cols=1, nnz/row (ave)=30, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 30.7367 nnz ave. (N=752) > [0] PCGAMGProlongator_AGG(): New grid 56 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=7.781296e+00 min=2.212257e-02 PC=jacobi > [0] PCSetUp_GAMG(): 4) N=56, n data cols=1, nnz/row (ave)=22, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 22.9643 nnz ave. (N=56) > [0] PCGAMGProlongator_AGG(): New grid 6 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.525086e+00 min=1.375043e-01 PC=jacobi > [0] PCSetUp_GAMG(): 5) N=6, n data cols=1, nnz/row (ave)=6, 1 active pes > [0] PCSetUp_GAMG(): 6 levels, grid complexity = 1.43876 > [0] PCSetUp_GAMG(): level 0) N=271201, n data rows=1, n data cols=1, nnz/row (ave)=5, np=1 > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 4.97455 nnz ave. (N=271201) > [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square > [0] PCGAMGProlongator_AGG(): New grid 38501 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.933798e+00 min=4.684075e-02 PC=jacobi > [0] PCSetUp_GAMG(): 1) N=38501, n data cols=1, nnz/row (ave)=10, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 10.7732 nnz ave. (N=38501) > [0] PCGAMGProlongator_AGG(): New grid 6664 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.623029e+00 min=1.250957e-02 PC=jacobi > [0] PCSetUp_GAMG(): 2) N=6664, n data cols=1, nnz/row (ave)=23, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 23.2098 nnz ave. (N=6664) > [0] PCGAMGProlongator_AGG(): New grid 620 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.763329e+00 min=1.611776e-02 PC=jacobi > [0] PCSetUp_GAMG(): 3) N=620, n data cols=1, nnz/row (ave)=29, 1 active pes > [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., 29.6129 nnz ave. (N=620) > [0] PCGAMGProlongator_AGG(): New grid 46 nodes > [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.497611e+00 min=2.630403e-02 PC=jacobi > [0] PCSetUp_GAMG(): 4) N=46, n data cols=1, nnz/row (ave)=20, 1 active pes > [0] PCSetUp_GAMG(): 5 levels, grid complexity = 1.43639 > > > > >> Il giorno 02 ago 2018, alle ore 17:39, Mark Adams > ha scritto: >> >> It looks like ML and hypre are working well now. If you want to debug GAMG you can run with -info, which is very noisy, and grep on GAMG or send the whole output. >> >> BTW, what equations are you solving? >> >> On Thu, Aug 2, 2018 at 5:12 AM Pierpaolo Minelli > wrote: >> Thank you very much for the correction. >> By rebalancing the matrix coefficients, making them dimensionless, in my complex problem i managed to obtain a better result with both ML and HYPRE. GAMG instead seems to be unable to converge and in fact I get unexpected results. I report the outputs of the three simulations again (i tried to use also -pc_gamg_square_graph 20 without any improvement). >> >> Pierpaolo >> >> -pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual >> >> 0 KSP preconditioned resid norm 1.984853668904e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 1.924446712661e-04 true resid norm 1.204260204811e-04 ||r(i)||/||b|| 4.041323752460e-02 >> 2 KSP preconditioned resid norm 5.161509100765e-06 true resid norm 2.810809726926e-06 ||r(i)||/||b|| 9.432672496933e-04 >> 3 KSP preconditioned resid norm 9.297326931238e-08 true resid norm 4.474617977876e-08 ||r(i)||/||b|| 1.501617328625e-05 >> 4 KSP preconditioned resid norm 1.910271882670e-09 true resid norm 9.637470658283e-10 ||r(i)||/||b|| 3.234196308186e-07 >> 0 KSP preconditioned resid norm 2.157687745805e+04 true resid norm 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 1.949268476386e+02 true resid norm 1.243419788627e+02 ||r(i)||/||b|| 3.907665598415e-02 >> 2 KSP preconditioned resid norm 5.078054475792e+00 true resid norm 2.745355604400e+00 ||r(i)||/||b|| 8.627763325675e-04 >> 3 KSP preconditioned resid norm 8.663802743529e-02 true resid norm 4.254290979292e-02 ||r(i)||/||b|| 1.336985839979e-05 >> 4 KSP preconditioned resid norm 1.795605563039e-03 true resid norm 9.040507428245e-04 ||r(i)||/||b|| 2.841138623714e-07 >> 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 >> 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 >> 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 >> 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 >> 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 >> >> -pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual >> >> 0 KSP preconditioned resid norm 1.825767020538e-02 true resid norm 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 6.495628259383e-04 true resid norm 3.739440526742e-04 ||r(i)||/||b|| 1.254902367550e-01 >> 2 KSP preconditioned resid norm 4.971875712015e-05 true resid norm 2.118856024328e-05 ||r(i)||/||b|| 7.110575559127e-03 >> 3 KSP preconditioned resid norm 3.726806462912e-06 true resid norm 1.370355844514e-06 ||r(i)||/||b|| 4.598716790303e-04 >> 4 KSP preconditioned resid norm 2.496898447120e-07 true resid norm 9.494701893753 > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Fri Aug 3 08:43:33 2018 From: jed at jedbrown.org (Jed Brown) Date: Fri, 03 Aug 2018 07:43:33 -0600 Subject: [petsc-users] Solving Linear Systems with Scalar Real and Complex In-Reply-To: References: <405250E7-D339-4F7A-BD0D-B008D6B3FC8D@cnr.it> <3B4B622A-EBCE-4E61-9039-CA8C34F730A4@cnr.it> <0ECD0720-31CA-443F-A44C-6703063B26B5@anl.gov> <583A6898-B577-495D-96C9-FFABA14B5B8D@cnr.it> Message-ID: <87sh3vwooq.fsf@jedbrown.org> Mark Adams writes: > From this output I can see that the eigenvalue estimates are strange. Your > equations look fine so I have to assume that the complex values are the > problem. If this is symmetric the CG is a much better solver and eigen > estimator. CG needs Hermitian positive definite. From knepley at gmail.com Fri Aug 3 09:11:18 2018 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 3 Aug 2018 10:11:18 -0400 Subject: [petsc-users] Solving Linear Systems with Scalar Real and Complex In-Reply-To: <6E8F7E03-DC50-4CBA-AA47-99949B893C9C@cnr.it> References: <405250E7-D339-4F7A-BD0D-B008D6B3FC8D@cnr.it> <3B4B622A-EBCE-4E61-9039-CA8C34F730A4@cnr.it> <0ECD0720-31CA-443F-A44C-6703063B26B5@anl.gov> <583A6898-B577-495D-96C9-FFABA14B5B8D@cnr.it> <6E8F7E03-DC50-4CBA-AA47-99949B893C9C@cnr.it> Message-ID: On Fri, Aug 3, 2018 at 9:42 AM Pierpaolo Minelli wrote: > I tried to use these options with GAMG: > > -mg_levels_ksp_type richardson > > -mg_levels_pc_type sor > > > but also in this case i don?t obtain a convergence. > Can you send the convergence and solver view so we can check? Also, if you send the matrix we can try running it. > I used also direct solvers (MUMPS ad SuperLU) and they works fine, but > slower (solve time) then iterative method with ML and hypre. > > If i check with -ksp_monitor_true_residual, is it advisable to continue > using the iterative method? > Yes. Matt > Pierpaolo > > > Il giorno 03 ago 2018, alle ore 15:16, Mark Adams ha > scritto: > > So this is a complex valued indefinite Helmholtz operator (very hard to > solve scalably) with axisymmetric coordinates. ML, hypre and GAMG all > performed about the same, with a big jump in residual initially and > essentially not solving it. You scaled it and this fixed ML and hypre but > not GAMG. > > From this output I can see that the eigenvalue estimates are strange. Your > equations look fine so I have to assume that the complex values are the > problem. If this is symmetric the CG is a much better solver and eigen > estimator. But this is not a big deal, especially since you have two > options that work. I would suggest not using cheby smoother, it uses these > bad eigen estimates, and it is basically not smoothing on some levels. You > can use this instead: > > -mg_levels_ksp_type richardson > -mg_levels_pc_type sor > > Note, if you have a large shift these equations are very hard to solve > iteratively and you should just use a direct solver. Direct solvers in 2D > are not bad, > > Mark > > > On Fri, Aug 3, 2018 at 3:02 AM Pierpaolo Minelli > wrote: > >> In this simulation I'm solving two equations in a two-dimensional domain >> (z,r) at each time step. The first is an equation derived from the Maxwell >> equation. Taking advantage of the fact that the domain is axialsymmetric >> and applying a temporal harmonic approximation, the equation I am solving >> is the following: >> >> >> The second equation is a Poisson?s equation in cylindrical coordinates >> (z,r) in the field of real numbers. >> >> This is the output obtained using these options (Note that at this moment >> of development I am only using a processor): >> >> *-pc_type gamg -pc_gamg_agg_nsmooths 1 -pc_gamg_reuse_interpolation true >> -pc_gamg_square_graph 1 -pc_gamg_threshold 0. -ksp_rtol 1.e-7 >> -ksp_max_it 30 -ksp_monitor_true_residual -info | grep GAMG* >> >> [0] PCSetUp_GAMG(): level 0) N=321201, n data rows=1, n data cols=1, >> nnz/row (ave)=5, np=1 >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 4.97011 nnz ave. (N=321201) >> [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square >> [0] PCGAMGProlongator_AGG(): New grid 45754 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.972526e+00 >> min=3.461411e-03 PC=jacobi >> [0] PCSetUp_GAMG(): 1) N=45754, n data cols=1, nnz/row (ave)=10, 1 active >> pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 10.7695 nnz ave. (N=45754) >> [0] PCGAMGProlongator_AGG(): New grid 7893 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=5.686837e+00 >> min=5.062501e-01 PC=jacobi >> [0] PCSetUp_GAMG(): 2) N=7893, n data cols=1, nnz/row (ave)=23, 1 active >> pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 23.2179 nnz ave. (N=7893) >> [0] PCGAMGProlongator_AGG(): New grid 752 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.504451e+01 >> min=2.124898e-02 PC=jacobi >> [0] PCSetUp_GAMG(): 3) N=752, n data cols=1, nnz/row (ave)=30, 1 active >> pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 30.7367 nnz ave. (N=752) >> [0] PCGAMGProlongator_AGG(): New grid 56 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=7.781296e+00 >> min=2.212257e-02 PC=jacobi >> [0] PCSetUp_GAMG(): 4) N=56, n data cols=1, nnz/row (ave)=22, 1 active pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 22.9643 nnz ave. (N=56) >> [0] PCGAMGProlongator_AGG(): New grid 6 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.525086e+00 >> min=1.375043e-01 PC=jacobi >> [0] PCSetUp_GAMG(): 5) N=6, n data cols=1, nnz/row (ave)=6, 1 active pes >> [0] PCSetUp_GAMG(): 6 levels, grid complexity = 1.43876 >> [0] PCSetUp_GAMG(): level 0) N=321201, n data rows=1, n data cols=1, >> nnz/row (ave)=5, np=1 >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 4.97011 nnz ave. (N=321201) >> [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square >> [0] PCGAMGProlongator_AGG(): New grid 45754 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.972526e+00 >> min=3.461411e-03 PC=jacobi >> [0] PCSetUp_GAMG(): 1) N=45754, n data cols=1, nnz/row (ave)=10, 1 active >> pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 10.7695 nnz ave. (N=45754) >> [0] PCGAMGProlongator_AGG(): New grid 7893 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=5.686837e+00 >> min=5.062501e-01 PC=jacobi >> [0] PCSetUp_GAMG(): 2) N=7893, n data cols=1, nnz/row (ave)=23, 1 active >> pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 23.2179 nnz ave. (N=7893) >> [0] PCGAMGProlongator_AGG(): New grid 752 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.504451e+01 >> min=2.124898e-02 PC=jacobi >> [0] PCSetUp_GAMG(): 3) N=752, n data cols=1, nnz/row (ave)=30, 1 active >> pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 30.7367 nnz ave. (N=752) >> [0] PCGAMGProlongator_AGG(): New grid 56 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=7.781296e+00 >> min=2.212257e-02 PC=jacobi >> [0] PCSetUp_GAMG(): 4) N=56, n data cols=1, nnz/row (ave)=22, 1 active pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 22.9643 nnz ave. (N=56) >> [0] PCGAMGProlongator_AGG(): New grid 6 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.525086e+00 >> min=1.375043e-01 PC=jacobi >> [0] PCSetUp_GAMG(): 5) N=6, n data cols=1, nnz/row (ave)=6, 1 active pes >> [0] PCSetUp_GAMG(): 6 levels, grid complexity = 1.43876 >> [0] PCSetUp_GAMG(): level 0) N=271201, n data rows=1, n data cols=1, >> nnz/row (ave)=5, np=1 >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 4.97455 nnz ave. (N=271201) >> [0] PCGAMGCoarsen_AGG(): Square Graph on level 1 of 1 to square >> [0] PCGAMGProlongator_AGG(): New grid 38501 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.933798e+00 >> min=4.684075e-02 PC=jacobi >> [0] PCSetUp_GAMG(): 1) N=38501, n data cols=1, nnz/row (ave)=10, 1 active >> pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 10.7732 nnz ave. (N=38501) >> [0] PCGAMGProlongator_AGG(): New grid 6664 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.623029e+00 >> min=1.250957e-02 PC=jacobi >> [0] PCSetUp_GAMG(): 2) N=6664, n data cols=1, nnz/row (ave)=23, 1 active >> pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 23.2098 nnz ave. (N=6664) >> [0] PCGAMGProlongator_AGG(): New grid 620 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.763329e+00 >> min=1.611776e-02 PC=jacobi >> [0] PCSetUp_GAMG(): 3) N=620, n data cols=1, nnz/row (ave)=29, 1 active >> pes >> [0] PCGAMGFilterGraph(): 100.% nnz after filtering, with threshold 0., >> 29.6129 nnz ave. (N=620) >> [0] PCGAMGProlongator_AGG(): New grid 46 nodes >> [0] PCGAMGOptProlongator_AGG(): Smooth P0: max eigen=1.497611e+00 >> min=2.630403e-02 PC=jacobi >> [0] PCSetUp_GAMG(): 4) N=46, n data cols=1, nnz/row (ave)=20, 1 active pes >> [0] PCSetUp_GAMG(): 5 levels, grid complexity = 1.43639 >> >> >> >> >> Il giorno 02 ago 2018, alle ore 17:39, Mark Adams ha >> scritto: >> >> It looks like ML and hypre are working well now. If you want to debug >> GAMG you can run with -info, which is very noisy, and grep on GAMG or send >> the whole output. >> >> BTW, what equations are you solving? >> >> On Thu, Aug 2, 2018 at 5:12 AM Pierpaolo Minelli < >> pierpaolo.minelli at cnr.it> wrote: >> >>> Thank you very much for the correction. >>> By rebalancing the matrix coefficients, making them dimensionless, in my >>> complex problem i managed to obtain a better result with both ML and HYPRE. >>> GAMG instead seems to be unable to converge and in fact I get unexpected >>> results. I report the outputs of the three simulations again (i tried to >>> use also -pc_gamg_square_graph 20 without any improvement). >>> >>> Pierpaolo >>> >>> *-pc_type hypre -ksp_rtol 1.e-7 -ksp_monitor_true_residual* >>> >>> 0 KSP preconditioned resid norm 1.984853668904e-02 true resid norm >>> 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 1.924446712661e-04 true resid norm >>> 1.204260204811e-04 ||r(i)||/||b|| 4.041323752460e-02 >>> 2 KSP preconditioned resid norm 5.161509100765e-06 true resid norm >>> 2.810809726926e-06 ||r(i)||/||b|| 9.432672496933e-04 >>> 3 KSP preconditioned resid norm 9.297326931238e-08 true resid norm >>> 4.474617977876e-08 ||r(i)||/||b|| 1.501617328625e-05 >>> 4 KSP preconditioned resid norm 1.910271882670e-09 true resid norm >>> 9.637470658283e-10 ||r(i)||/||b|| 3.234196308186e-07 >>> 0 KSP preconditioned resid norm 2.157687745805e+04 true resid norm >>> 3.182001523188e+03 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 1.949268476386e+02 true resid norm >>> 1.243419788627e+02 ||r(i)||/||b|| 3.907665598415e-02 >>> 2 KSP preconditioned resid norm 5.078054475792e+00 true resid norm >>> 2.745355604400e+00 ||r(i)||/||b|| 8.627763325675e-04 >>> 3 KSP preconditioned resid norm 8.663802743529e-02 true resid norm >>> 4.254290979292e-02 ||r(i)||/||b|| 1.336985839979e-05 >>> 4 KSP preconditioned resid norm 1.795605563039e-03 true resid norm >>> 9.040507428245e-04 ||r(i)||/||b|| 2.841138623714e-07 >>> 0 KSP preconditioned resid norm 6.728304961395e+02 true resid norm >>> 1.879478105170e+02 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 2.190497539532e+01 true resid norm >>> 4.630095820203e+02 ||r(i)||/||b|| 2.463500802413e+00 >>> 2 KSP preconditioned resid norm 8.425561564252e-01 true resid norm >>> 7.012565302251e+01 ||r(i)||/||b|| 3.731123700223e-01 >>> 3 KSP preconditioned resid norm 3.029848345705e-02 true resid norm >>> 4.379018464663e+00 ||r(i)||/||b|| 2.329911932795e-02 >>> 4 KSP preconditioned resid norm 7.374025528575e-04 true resid norm >>> 1.337183702137e-01 ||r(i)||/||b|| 7.114654320570e-04 >>> 5 KSP preconditioned resid norm 3.009400175162e-05 true resid norm >>> 7.731135032616e-03 ||r(i)||/||b|| 4.113447776459e-05 >>> >>> *-pc_type ml -ksp_rtol 1.e-7 -ksp_monitor_true_residual* >>> >>> 0 KSP preconditioned resid norm 1.825767020538e-02 true resid norm >>> 2.979865703850e-03 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 6.495628259383e-04 true resid norm >>> 3.739440526742e-04 ||r(i)||/||b|| 1.254902367550e-01 >>> 2 KSP preconditioned resid norm 4.971875712015e-05 true resid norm >>> 2.118856024328e-05 ||r(i)||/||b|| 7.110575559127e-03 >>> 3 KSP preconditioned resid norm 3.726806462912e-06 true resid norm >>> 1.370355844514e-06 ||r(i)||/||b|| 4.598716790303e-04 >>> 4 KSP preconditioned resid norm 2.496898447120e-07 true resid norm >>> 9.494701893753 >>> >> > > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Fri Aug 3 12:59:41 2018 From: jed at jedbrown.org (Jed Brown) Date: Fri, 03 Aug 2018 11:59:41 -0600 Subject: [petsc-users] MatDenseGetArrayF90 In-Reply-To: References: Message-ID: <87k1p7wctu.fsf@jedbrown.org> Marius Buerkle writes: > Hi > > When using MatDenseGetArrayF90 only the diaognal part of the matrix is > returned. Is it possible to get the whole matrix? You should get the entire block row (local size m by global size N). From mbuerkle at web.de Fri Aug 3 13:32:51 2018 From: mbuerkle at web.de (Marius Buerkle) Date: Fri, 3 Aug 2018 20:32:51 +0200 Subject: [petsc-users] MatDenseGetArrayF90 In-Reply-To: <87k1p7wctu.fsf@jedbrown.org> References: <87k1p7wctu.fsf@jedbrown.org> Message-ID: No I don't get the whole block, only the diagonal block of the matrix. Maybe I am doing something wrong. > > Marius Buerkle writes: > > > Hi > > > > When using MatDenseGetArrayF90 only the diaognal part of the matrix is > > returned. Is it possible to get the whole matrix? > > You should get the entire block row (local size m by global size N). > From jed at jedbrown.org Fri Aug 3 13:42:10 2018 From: jed at jedbrown.org (Jed Brown) Date: Fri, 03 Aug 2018 12:42:10 -0600 Subject: [petsc-users] MatDenseGetArrayF90 In-Reply-To: References: <87k1p7wctu.fsf@jedbrown.org> Message-ID: <87efffwav1.fsf@jedbrown.org> Can you test the patch below? diff --git i/src/mat/interface/f90-custom/zmatrixf90.c w/src/mat/interface/f90-custom/zmatrixf90.c index 0497d33fe7..7b2ab1011f 100644 --- i/src/mat/interface/f90-custom/zmatrixf90.c +++ w/src/mat/interface/f90-custom/zmatrixf90.c @@ -31,10 +31,11 @@ PETSC_EXTERN void PETSC_STDCALL matgetghostsf90_(Mat *mat,F90Array1d *ptr,int *i PETSC_EXTERN void PETSC_STDCALL matdensegetarrayf90_(Mat *mat,F90Array2d *ptr,int *ierr PETSC_F90_2PTR_PROTO(ptrd)) { PetscScalar *fa; - PetscInt m,n; + PetscInt m,N; *ierr = MatDenseGetArray(*mat,&fa); if (*ierr) return; - *ierr = MatGetLocalSize(*mat,&m,&n); if (*ierr) return; - *ierr = F90Array2dCreate(fa,MPIU_SCALAR,1,m,1,n,ptr PETSC_F90_2PTR_PARAM(ptrd)); + *ierr = MatGetLocalSize(*mat,&m,NULL); if (*ierr) return; + *ierr = MatGetSize(*mat,NULL,&N); if (*ierr) return; + *ierr = F90Array2dCreate(fa,MPIU_SCALAR,1,m,1,N,ptr PETSC_F90_2PTR_PARAM(ptrd)); } PETSC_EXTERN void PETSC_STDCALL matdenserestorearrayf90_(Mat *mat,F90Array2d *ptr,int *ierr PETSC_F90_2PTR_PROTO(ptrd)) { Marius Buerkle writes: > No I don't get the whole block, only the diagonal block of the matrix. Maybe I am doing something wrong. > >> >> Marius Buerkle writes: >> >> > Hi >> > >> > When using MatDenseGetArrayF90 only the diaognal part of the matrix is >> > returned. Is it possible to get the whole matrix? >> >> You should get the entire block row (local size m by global size N). >> From bsmith at mcs.anl.gov Fri Aug 3 13:45:51 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Fri, 3 Aug 2018 18:45:51 +0000 Subject: [petsc-users] MatDenseGetArrayF90 In-Reply-To: References: <87k1p7wctu.fsf@jedbrown.org> Message-ID: <9BDE8A8D-94D8-4B87-B010-02F6C1CE3C91@anl.gov> > On Aug 3, 2018, at 1:32 PM, Marius Buerkle wrote: > > No I don't get the whole block, only the diagonal block of the matrix. Maybe I am doing something wrong. What do you mean by diagonal block? MatDenseGetArrayF90() returns the entire set of rows owned by that process (and all the columns). It does not return the entire matrix across all processes; each process gets its part of the matrix. Barry It is simply not possible for it to be returning only the "diagonal block" portion of the matrix (to use the PETSc terminology diagonal block) because dense matrices with PETSc do not store a separate diagonal block they just store one the entire local part of the matrix in a single array. > >> >> Marius Buerkle writes: >> >>> Hi >>> >>> When using MatDenseGetArrayF90 only the diaognal part of the matrix is >>> returned. Is it possible to get the whole matrix? >> >> You should get the entire block row (local size m by global size N). >> From bsmith at mcs.anl.gov Fri Aug 3 13:47:30 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Fri, 3 Aug 2018 18:47:30 +0000 Subject: [petsc-users] MatDenseGetArrayF90 In-Reply-To: <87efffwav1.fsf@jedbrown.org> References: <87k1p7wctu.fsf@jedbrown.org> <87efffwav1.fsf@jedbrown.org> Message-ID: <47A3CC67-846E-4D21-84E7-C542A7805D9A@anl.gov> Yikes, bad bug. It wasn't returning the diagonal block just the wrong wrong size for columns. Barry > On Aug 3, 2018, at 1:42 PM, Jed Brown wrote: > > Can you test the patch below? > > > diff --git i/src/mat/interface/f90-custom/zmatrixf90.c w/src/mat/interface/f90-custom/zmatrixf90.c > index 0497d33fe7..7b2ab1011f 100644 > --- i/src/mat/interface/f90-custom/zmatrixf90.c > +++ w/src/mat/interface/f90-custom/zmatrixf90.c > @@ -31,10 +31,11 @@ PETSC_EXTERN void PETSC_STDCALL matgetghostsf90_(Mat *mat,F90Array1d *ptr,int *i > PETSC_EXTERN void PETSC_STDCALL matdensegetarrayf90_(Mat *mat,F90Array2d *ptr,int *ierr PETSC_F90_2PTR_PROTO(ptrd)) > { > PetscScalar *fa; > - PetscInt m,n; > + PetscInt m,N; > *ierr = MatDenseGetArray(*mat,&fa); if (*ierr) return; > - *ierr = MatGetLocalSize(*mat,&m,&n); if (*ierr) return; > - *ierr = F90Array2dCreate(fa,MPIU_SCALAR,1,m,1,n,ptr PETSC_F90_2PTR_PARAM(ptrd)); > + *ierr = MatGetLocalSize(*mat,&m,NULL); if (*ierr) return; > + *ierr = MatGetSize(*mat,NULL,&N); if (*ierr) return; > + *ierr = F90Array2dCreate(fa,MPIU_SCALAR,1,m,1,N,ptr PETSC_F90_2PTR_PARAM(ptrd)); > } > PETSC_EXTERN void PETSC_STDCALL matdenserestorearrayf90_(Mat *mat,F90Array2d *ptr,int *ierr PETSC_F90_2PTR_PROTO(ptrd)) > { > > > Marius Buerkle writes: > >> No I don't get the whole block, only the diagonal block of the matrix. Maybe I am doing something wrong. >> >>> >>> Marius Buerkle writes: >>> >>>> Hi >>>> >>>> When using MatDenseGetArrayF90 only the diaognal part of the matrix is >>>> returned. Is it possible to get the whole matrix? >>> >>> You should get the entire block row (local size m by global size N). >>> From jed at jedbrown.org Fri Aug 3 15:22:42 2018 From: jed at jedbrown.org (Jed Brown) Date: Fri, 03 Aug 2018 14:22:42 -0600 Subject: [petsc-users] MatDenseGetArrayF90 In-Reply-To: <47A3CC67-846E-4D21-84E7-C542A7805D9A@anl.gov> References: <87k1p7wctu.fsf@jedbrown.org> <87efffwav1.fsf@jedbrown.org> <47A3CC67-846E-4D21-84E7-C542A7805D9A@anl.gov> Message-ID: <877el7w67h.fsf@jedbrown.org> https://bitbucket.org/petsc/petsc/pull-requests/1064/jed-fix-matdensegetarrayf90-maint/diff "Smith, Barry F." writes: > Yikes, bad bug. It wasn't returning the diagonal block just the wrong wrong size for columns. > > Barry > > >> On Aug 3, 2018, at 1:42 PM, Jed Brown wrote: >> >> Can you test the patch below? >> >> >> diff --git i/src/mat/interface/f90-custom/zmatrixf90.c w/src/mat/interface/f90-custom/zmatrixf90.c >> index 0497d33fe7..7b2ab1011f 100644 >> --- i/src/mat/interface/f90-custom/zmatrixf90.c >> +++ w/src/mat/interface/f90-custom/zmatrixf90.c >> @@ -31,10 +31,11 @@ PETSC_EXTERN void PETSC_STDCALL matgetghostsf90_(Mat *mat,F90Array1d *ptr,int *i >> PETSC_EXTERN void PETSC_STDCALL matdensegetarrayf90_(Mat *mat,F90Array2d *ptr,int *ierr PETSC_F90_2PTR_PROTO(ptrd)) >> { >> PetscScalar *fa; >> - PetscInt m,n; >> + PetscInt m,N; >> *ierr = MatDenseGetArray(*mat,&fa); if (*ierr) return; >> - *ierr = MatGetLocalSize(*mat,&m,&n); if (*ierr) return; >> - *ierr = F90Array2dCreate(fa,MPIU_SCALAR,1,m,1,n,ptr PETSC_F90_2PTR_PARAM(ptrd)); >> + *ierr = MatGetLocalSize(*mat,&m,NULL); if (*ierr) return; >> + *ierr = MatGetSize(*mat,NULL,&N); if (*ierr) return; >> + *ierr = F90Array2dCreate(fa,MPIU_SCALAR,1,m,1,N,ptr PETSC_F90_2PTR_PARAM(ptrd)); >> } >> PETSC_EXTERN void PETSC_STDCALL matdenserestorearrayf90_(Mat *mat,F90Array2d *ptr,int *ierr PETSC_F90_2PTR_PROTO(ptrd)) >> { >> >> >> Marius Buerkle writes: >> >>> No I don't get the whole block, only the diagonal block of the matrix. Maybe I am doing something wrong. >>> >>>> >>>> Marius Buerkle writes: >>>> >>>>> Hi >>>>> >>>>> When using MatDenseGetArrayF90 only the diaognal part of the matrix is >>>>> returned. Is it possible to get the whole matrix? >>>> >>>> You should get the entire block row (local size m by global size N). >>>> From jed at jedbrown.org Fri Aug 3 23:32:16 2018 From: jed at jedbrown.org (Jed Brown) Date: Fri, 03 Aug 2018 22:32:16 -0600 Subject: [petsc-users] Parallel QR decomposition In-Reply-To: References: Message-ID: <87va8qvjjj.fsf@jedbrown.org> David Sommer writes: > Hi, > > sorry i haven't answered in a while. >>> i was wondering if there is an implementation of parallel qr > decomposition in PETSc. >> For what purpose do you need a QR? We may have suggestions if we know > how you want to use it. > I found an interesting algorithm for radial basis function interpolation. > It mitigates the ill-conditioning that arises from making radial basis > functions increasingly flat. The paper can be found at > https://amath.colorado.edu/faculty/fornberg/Docs/SISCmanuscript.pdf > The algorithm defines a Matrix C that is rectangular (more columns than > rows). Then a QR Decomposition of C is computed. It looks like this: > C = Q [R1 R2] > with R1 being rectangular and R2 being stacked on it horizontally. What i > want to compute in the end is: > R_1^{-1} R_2 Is R_1 square? What is a typical shape for C? > Which isn't that hard to compute once R is known, as this is just backward > substitution. Anyway i still need to do a full QR decomposition (Even > though i don't actually need Q, it would be easy to calculate from R, That is usually not stable. You usually want the Q as produced by QR, preferably the elementary reflector representation. > so i don't think there is any shortcut to Q, except that i don't have > to store Q). What i was thinking of as a possible solution is to > parallelize Givens rotations by leveraging the fact that it only has > local row-wise data dependencies in each step. > > Best regards > > David Sommer From youjunhu at gmail.com Sat Aug 4 11:39:14 2018 From: youjunhu at gmail.com (Youjun Hu) Date: Sat, 4 Aug 2018 10:39:14 -0600 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? Message-ID: Hi all, I am just wondering why PETSc introduces PetscScalar datatype in addition to the PetscReal and PetscComplex. Could someone help clarify the rationale behind this design? I am primarily a Fortran guy. The additional datatype PetscScalar seems to only confuse me rather than provide me any flexibility. Cheers, Youjun Hu -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sat Aug 4 12:03:04 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Sat, 4 Aug 2018 17:03:04 +0000 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: References: Message-ID: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> For a particular configuration (./configure --with-scalar-type= real or complex) the PETSc objects, such as vectors and matrices either contain real values or complex values. In the same running code it is not possible to have some vectors with real numbers and some vectors with complex numbers. Depending on how you configure PETSc ./configure --with-scalar-type= real or complex the variable name PetscScalar becomes either PetscReal or PetscComplex. PETSc code is written with PetscScalar so we can reconfigure the same source code and have it work with real numbers or complex. For users who just work with real numbers you can simply use PetscReal as your variable type. If working with just with complex numbers you can use PetscComplex. If you want to sometimes configure with real numbers and sometimes configure with complex (which is not common) you use PetscScalar. Barry > On Aug 4, 2018, at 11:39 AM, Youjun Hu wrote: > > Hi all, > > I am just wondering why PETSc introduces PetscScalar datatype in addition to the PetscReal and PetscComplex. > Could someone help clarify the rationale behind this design? > I am primarily a Fortran guy. The additional datatype PetscScalar seems to only confuse me rather than provide me any flexibility. > Cheers, > Youjun Hu From t.appel17 at imperial.ac.uk Sat Aug 4 12:33:35 2018 From: t.appel17 at imperial.ac.uk (Appel, Thibaut) Date: Sat, 4 Aug 2018 17:33:35 +0000 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? Message-ID: <3C742AF8-11CF-43DA-9F6E-037C66D7639B@imperial.ac.uk> Hi, I can?t speak from a design point of view since I didn?t write PETSc myself but I assume it was to have more compact source files and to avoid copying routines twice (with one version for real and one version for complex). I am also using Fortran and it is actually flexible, as it allows you to write a unique version of your application code that works for both arithmetic types. If you need to write different pieces of code at some point, you can include preprocessed directives through the use of the PETSC_USE_COMPLEX boolean that is known at compilation time. Thibaut > Hi all, > > I am just wondering why PETSc introduces PetscScalar datatype in addition > to the PetscReal and PetscComplex. > Could someone help clarify the rationale behind this design? > I am primarily a Fortran guy. The additional datatype PetscScalar seems to > only confuse me rather than provide me any flexibility. > Cheers, > Youjun Hu From youjunhu at gmail.com Sat Aug 4 13:11:39 2018 From: youjunhu at gmail.com (Youjun Hu) Date: Sat, 4 Aug 2018 12:11:39 -0600 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> References: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> Message-ID: Thank Barry for the clarification. In summary, application code developers should choose the specific datatypes (PetscReal and PetscComplex) rather than the more general datatype PetscScalar because application codes usually have fixed datatype and the flexibility provided by PetscScalar is for PETSc library developers and usually not for application developers. If an application developer uses PetscScalar to declare a variable that is intended by the developer to be complex and is assigned a complex value later in the code and then used in, e.g., MatSetValues, but it happens that petsc is configured with --with-scalar-type=real then, it is not possible for this error to be detected at compiling time. If the developer specify PetscComplex, then this inconsistency can be seen by compilers and hopefully an error message can be raised during compiling. Conclusion: avoid using PetscScalar in application codes unless it is absolutely needed (which is not common). The example application codes provided in tutor folds of petsc often use PetscScalar, which is a little misleading and should better be revised to use concrete datatypes. Correct me if anybody finds this conclusion is not justified. Cheers, Youjun On Sat, Aug 4, 2018 at 11:03 AM Smith, Barry F. wrote: > > For a particular configuration (./configure --with-scalar-type= real or > complex) the PETSc objects, such as vectors and matrices either contain > real values or complex values. In the same running code it is not possible > to have some vectors with real numbers and some vectors with complex > numbers. > > Depending on how you configure PETSc ./configure --with-scalar-type= > real or complex the variable name PetscScalar becomes either PetscReal or > PetscComplex. PETSc code is written with PetscScalar so we can reconfigure > the same source code and have it work with real numbers or complex. > > For users who just work with real numbers you can simply use PetscReal > as your variable type. If working with just with complex numbers you can > use PetscComplex. If you want to sometimes configure with real numbers and > sometimes configure with complex (which is not common) you use PetscScalar. > > Barry > > > > On Aug 4, 2018, at 11:39 AM, Youjun Hu wrote: > > > > Hi all, > > > > I am just wondering why PETSc introduces PetscScalar datatype in > addition to the PetscReal and PetscComplex. > > Could someone help clarify the rationale behind this design? > > I am primarily a Fortran guy. The additional datatype PetscScalar seems > to only confuse me rather than provide me any flexibility. > > Cheers, > > Youjun Hu > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From youjunhu at gmail.com Sat Aug 4 13:19:12 2018 From: youjunhu at gmail.com (Youjun Hu) Date: Sat, 4 Aug 2018 12:19:12 -0600 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: <3C742AF8-11CF-43DA-9F6E-037C66D7639B@imperial.ac.uk> References: <3C742AF8-11CF-43DA-9F6E-037C66D7639B@imperial.ac.uk> Message-ID: Thank Thibaut for the information. There is often no clear boundary between library codes and application codes. For library codes, we do need the flexibility provided by the abstraction. Cheers, Youjun On Sat, Aug 4, 2018 at 11:33 AM Appel, Thibaut wrote: > Hi, > > I can?t speak from a design point of view since I didn?t write PETSc > myself but I assume it was to have more compact source files and to avoid > copying routines twice (with one version for real and one version for > complex). > > I am also using Fortran and it is actually flexible, as it allows you to > write a unique version of your application code that works for both > arithmetic types. If you need to write different pieces of code at some > point, you can include preprocessed directives through the use of the > PETSC_USE_COMPLEX boolean that is known at compilation time. > > Thibaut > > > Hi all, > > > > I am just wondering why PETSc introduces PetscScalar datatype in addition > > to the PetscReal and PetscComplex. > > Could someone help clarify the rationale behind this design? > > I am primarily a Fortran guy. The additional datatype PetscScalar seems > to > > only confuse me rather than provide me any flexibility. > > Cheers, > > Youjun Hu > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sat Aug 4 13:28:21 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Sat, 4 Aug 2018 18:28:21 +0000 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: References: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> Message-ID: <387682AF-213C-472A-9A01-C73567F487B6@mcs.anl.gov> > On Aug 4, 2018, at 1:11 PM, Youjun Hu wrote: > > Thank Barry for the clarification. > In summary, application code developers should choose the specific datatypes (PetscReal and PetscComplex) rather than the more general datatype PetscScalar > because application codes usually have fixed datatype and the flexibility provided by PetscScalar is for PETSc library developers and usually not for application developers. > If an application developer uses PetscScalar to declare a variable that is intended by the developer to be complex and is assigned a complex value later in the code and then used in, e.g., MatSetValues, but it happens that petsc is configured with --with-scalar-type=real > then, it is not possible for this error to be detected at compiling time. If the developer specify PetscComplex, then this inconsistency can be seen by compilers and hopefully an error message can be raised during compiling. > > Conclusion: avoid using PetscScalar in application codes unless it is absolutely needed (which is not common). The example application codes provided in tutor folds of petsc often use PetscScalar, which is a little misleading and should better be revised to use concrete datatypes. The reason the examples use PetscScalar is so that all the examples can be used to test both the real and complex versions of the libraries. If they used the specific types they could only be testing one or the other. Note there is no harm in writing applications with PetscScalar it is just usually not needed. Barry > Correct me if anybody finds this conclusion is not justified. > > Cheers, > Youjun > > > > On Sat, Aug 4, 2018 at 11:03 AM Smith, Barry F. wrote: > > For a particular configuration (./configure --with-scalar-type= real or complex) the PETSc objects, such as vectors and matrices either contain real values or complex values. In the same running code it is not possible to have some vectors with real numbers and some vectors with complex numbers. > > Depending on how you configure PETSc ./configure --with-scalar-type= real or complex the variable name PetscScalar becomes either PetscReal or PetscComplex. PETSc code is written with PetscScalar so we can reconfigure the same source code and have it work with real numbers or complex. > > For users who just work with real numbers you can simply use PetscReal as your variable type. If working with just with complex numbers you can use PetscComplex. If you want to sometimes configure with real numbers and sometimes configure with complex (which is not common) you use PetscScalar. > > Barry > > > > On Aug 4, 2018, at 11:39 AM, Youjun Hu wrote: > > > > Hi all, > > > > I am just wondering why PETSc introduces PetscScalar datatype in addition to the PetscReal and PetscComplex. > > Could someone help clarify the rationale behind this design? > > I am primarily a Fortran guy. The additional datatype PetscScalar seems to only confuse me rather than provide me any flexibility. > > Cheers, > > Youjun Hu > From youjunhu at gmail.com Sat Aug 4 15:02:02 2018 From: youjunhu at gmail.com (Youjun Hu) Date: Sat, 4 Aug 2018 14:02:02 -0600 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: References: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> Message-ID: When having lunch at a garden under wonderful autumn sky, I realized that the tutorial examples are designed to test both the real and complex versions and thus they must be general enough. My complaint about the tutourial examples are not justified. Cheers, Youjun On Sat, Aug 4, 2018 at 12:37 PM Dave May wrote: > > > On 4 August 2018 at 19:11, Youjun Hu wrote: > >> Thank Barry for the clarification. >> In summary, application code developers should choose the specific >> datatypes (PetscReal and PetscComplex) rather than the more general >> datatype PetscScalar >> because application codes usually have fixed datatype and the flexibility >> provided by PetscScalar is for PETSc library developers and usually not for >> application developers. >> If an application developer uses PetscScalar to declare a variable that >> is intended by the developer to be complex and is assigned a complex value >> later in the code and then used in, e.g., MatSetValues, but it happens >> that petsc is configured with --with-scalar-type=real >> then, it is not possible for this error to be detected at compiling time. >> If the developer specify PetscComplex, then this inconsistency can be seen >> by compilers and hopefully an error message can be raised during compiling. >> >> Conclusion: avoid using PetscScalar in application codes unless it is >> absolutely needed (which is not common). >> > > > >> The example application codes provided in tutor folds of petsc often use >> PetscScalar, which is a little misleading and should better be revised to >> use concrete datatypes. >> Correct me if anybody finds this conclusion is not justified. >> > > Not justified. > > Tutorial examples serve several purposes: > > 1/ To illustrate the point Barry made. e.g. they demonstrate how a user > can write a single application code which works with both complex and real > configurations. > > 2/ The examples are also used in the testing suite which employs a > multitude of petsc configuration combinations, e.g single precision > {real,complex|, double precision {real,complex}, __float128. > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From youjunhu at gmail.com Sat Aug 4 16:13:56 2018 From: youjunhu at gmail.com (Youjun Hu) Date: Sat, 4 Aug 2018 15:13:56 -0600 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: <387682AF-213C-472A-9A01-C73567F487B6@mcs.anl.gov> References: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> <387682AF-213C-472A-9A01-C73567F487B6@mcs.anl.gov> Message-ID: I just tried to change PetscScalar to the specific datatype PetscComplex in my Fortran code, but the compiler raised the following error: PetscComplex my_coeff Error: Unclassifiable statement at (1) It seems that the compiler does not know this datatype. My Petsc was configured with ./configure --with-scalar-type=complex --with-precision=double Before the modification, the code was complied successfully. Could someone help? Thanks, Youjun On Sat, Aug 4, 2018 at 12:28 PM Smith, Barry F. wrote: > > > > On Aug 4, 2018, at 1:11 PM, Youjun Hu wrote: > > > > Thank Barry for the clarification. > > In summary, application code developers should choose the specific > datatypes (PetscReal and PetscComplex) rather than the more general > datatype PetscScalar > > because application codes usually have fixed datatype and the > flexibility provided by PetscScalar is for PETSc library developers and > usually not for application developers. > > If an application developer uses PetscScalar to declare a variable that > is intended by the developer to be complex and is assigned a complex value > later in the code and then used in, e.g., MatSetValues, but it happens > that petsc is configured with --with-scalar-type=real > > then, it is not possible for this error to be detected at compiling > time. If the developer specify PetscComplex, then this inconsistency can be > seen by compilers and hopefully an error message can be raised during > compiling. > > > > Conclusion: avoid using PetscScalar in application codes unless it is > absolutely needed (which is not common). The example application codes > provided in tutor folds of petsc often use PetscScalar, which is a little > misleading and should better be revised to use concrete datatypes. > > The reason the examples use PetscScalar is so that all the examples > can be used to test both the real and complex versions of the libraries. If > they used the specific types they could only be testing one or the other. > > Note there is no harm in writing applications with PetscScalar it is > just usually not needed. > > Barry > > > Correct me if anybody finds this conclusion is not justified. > > > > Cheers, > > Youjun > > > > > > > > On Sat, Aug 4, 2018 at 11:03 AM Smith, Barry F. > wrote: > > > > For a particular configuration (./configure --with-scalar-type= real > or complex) the PETSc objects, such as vectors and matrices either contain > real values or complex values. In the same running code it is not possible > to have some vectors with real numbers and some vectors with complex > numbers. > > > > Depending on how you configure PETSc ./configure --with-scalar-type= > real or complex the variable name PetscScalar becomes either PetscReal or > PetscComplex. PETSc code is written with PetscScalar so we can reconfigure > the same source code and have it work with real numbers or complex. > > > > For users who just work with real numbers you can simply use > PetscReal as your variable type. If working with just with complex numbers > you can use PetscComplex. If you want to sometimes configure with real > numbers and sometimes configure with complex (which is not common) you use > PetscScalar. > > > > Barry > > > > > > > On Aug 4, 2018, at 11:39 AM, Youjun Hu wrote: > > > > > > Hi all, > > > > > > I am just wondering why PETSc introduces PetscScalar datatype in > addition to the PetscReal and PetscComplex. > > > Could someone help clarify the rationale behind this design? > > > I am primarily a Fortran guy. The additional datatype PetscScalar > seems to only confuse me rather than provide me any flexibility. > > > Cheers, > > > Youjun Hu > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Sat Aug 4 16:24:13 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Sat, 4 Aug 2018 16:24:13 -0500 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: References: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> <387682AF-213C-472A-9A01-C73567F487B6@mcs.anl.gov> Message-ID: For some reason it is PetscFortranComplex [on fortran side] I'm not sure I understand your logic for using PetscComplex and not PetscScalar. We recommend using PetscScalar. You can choose not to follow our recommendation. But we don't say 'PetscScalar' is the wrong thing for users [as you appear to infer] Satish On Sat, 4 Aug 2018, Youjun Hu wrote: > I just tried to change PetscScalar to the specific datatype PetscComplex in > my Fortran code, but the compiler raised the following error: > PetscComplex my_coeff > Error: Unclassifiable statement at (1) > > It seems that the compiler does not know this datatype. > > My Petsc was configured with ./configure --with-scalar-type=complex > --with-precision=double > > Before the modification, the code was complied successfully. > Could someone help? > > Thanks, > Youjun > > On Sat, Aug 4, 2018 at 12:28 PM Smith, Barry F. wrote: > > > > > > > > On Aug 4, 2018, at 1:11 PM, Youjun Hu wrote: > > > > > > Thank Barry for the clarification. > > > In summary, application code developers should choose the specific > > datatypes (PetscReal and PetscComplex) rather than the more general > > datatype PetscScalar > > > because application codes usually have fixed datatype and the > > flexibility provided by PetscScalar is for PETSc library developers and > > usually not for application developers. > > > If an application developer uses PetscScalar to declare a variable that > > is intended by the developer to be complex and is assigned a complex value > > later in the code and then used in, e.g., MatSetValues, but it happens > > that petsc is configured with --with-scalar-type=real > > > then, it is not possible for this error to be detected at compiling > > time. If the developer specify PetscComplex, then this inconsistency can be > > seen by compilers and hopefully an error message can be raised during > > compiling. > > > > > > Conclusion: avoid using PetscScalar in application codes unless it is > > absolutely needed (which is not common). The example application codes > > provided in tutor folds of petsc often use PetscScalar, which is a little > > misleading and should better be revised to use concrete datatypes. > > > > The reason the examples use PetscScalar is so that all the examples > > can be used to test both the real and complex versions of the libraries. If > > they used the specific types they could only be testing one or the other. > > > > Note there is no harm in writing applications with PetscScalar it is > > just usually not needed. > > > > Barry > > > > > Correct me if anybody finds this conclusion is not justified. > > > > > > Cheers, > > > Youjun > > > > > > > > > > > > On Sat, Aug 4, 2018 at 11:03 AM Smith, Barry F. > > wrote: > > > > > > For a particular configuration (./configure --with-scalar-type= real > > or complex) the PETSc objects, such as vectors and matrices either contain > > real values or complex values. In the same running code it is not possible > > to have some vectors with real numbers and some vectors with complex > > numbers. > > > > > > Depending on how you configure PETSc ./configure --with-scalar-type= > > real or complex the variable name PetscScalar becomes either PetscReal or > > PetscComplex. PETSc code is written with PetscScalar so we can reconfigure > > the same source code and have it work with real numbers or complex. > > > > > > For users who just work with real numbers you can simply use > > PetscReal as your variable type. If working with just with complex numbers > > you can use PetscComplex. If you want to sometimes configure with real > > numbers and sometimes configure with complex (which is not common) you use > > PetscScalar. > > > > > > Barry > > > > > > > > > > On Aug 4, 2018, at 11:39 AM, Youjun Hu wrote: > > > > > > > > Hi all, > > > > > > > > I am just wondering why PETSc introduces PetscScalar datatype in > > addition to the PetscReal and PetscComplex. > > > > Could someone help clarify the rationale behind this design? > > > > I am primarily a Fortran guy. The additional datatype PetscScalar > > seems to only confuse me rather than provide me any flexibility. > > > > Cheers, > > > > Youjun Hu > > > > > > > > From balay at mcs.anl.gov Sat Aug 4 16:33:43 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Sat, 4 Aug 2018 16:33:43 -0500 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: References: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> <387682AF-213C-472A-9A01-C73567F487B6@mcs.anl.gov> Message-ID: You could try the following fix. diff --git a/include/petsc/finclude/petscsys.h b/include/petsc/finclude/petscsys.h index 4ca4ebb8ba..cffbafd475 100644 --- a/include/petsc/finclude/petscsys.h +++ b/include/petsc/finclude/petscsys.h @@ -150,6 +150,7 @@ ! ! Macro for templating between real and complex ! +#define PetscComplex PetscFortranComplex #if defined(PETSC_USE_COMPLEX) #define PetscScalar PetscFortranComplex ! Satish On Sat, 4 Aug 2018, Satish Balay wrote: > For some reason it is PetscFortranComplex [on fortran side] > > I'm not sure I understand your logic for using PetscComplex and not PetscScalar. > > We recommend using PetscScalar. You can choose not to follow our > recommendation. > > But we don't say 'PetscScalar' is the wrong thing for users [as you > appear to infer] > > Satish > > On Sat, 4 Aug 2018, Youjun Hu wrote: > > > I just tried to change PetscScalar to the specific datatype PetscComplex in > > my Fortran code, but the compiler raised the following error: > > PetscComplex my_coeff > > Error: Unclassifiable statement at (1) > > > > It seems that the compiler does not know this datatype. > > > > My Petsc was configured with ./configure --with-scalar-type=complex > > --with-precision=double > > > > Before the modification, the code was complied successfully. > > Could someone help? > > > > Thanks, > > Youjun > > > > On Sat, Aug 4, 2018 at 12:28 PM Smith, Barry F. wrote: > > > > > > > > > > > > On Aug 4, 2018, at 1:11 PM, Youjun Hu wrote: > > > > > > > > Thank Barry for the clarification. > > > > In summary, application code developers should choose the specific > > > datatypes (PetscReal and PetscComplex) rather than the more general > > > datatype PetscScalar > > > > because application codes usually have fixed datatype and the > > > flexibility provided by PetscScalar is for PETSc library developers and > > > usually not for application developers. > > > > If an application developer uses PetscScalar to declare a variable that > > > is intended by the developer to be complex and is assigned a complex value > > > later in the code and then used in, e.g., MatSetValues, but it happens > > > that petsc is configured with --with-scalar-type=real > > > > then, it is not possible for this error to be detected at compiling > > > time. If the developer specify PetscComplex, then this inconsistency can be > > > seen by compilers and hopefully an error message can be raised during > > > compiling. > > > > > > > > Conclusion: avoid using PetscScalar in application codes unless it is > > > absolutely needed (which is not common). The example application codes > > > provided in tutor folds of petsc often use PetscScalar, which is a little > > > misleading and should better be revised to use concrete datatypes. > > > > > > The reason the examples use PetscScalar is so that all the examples > > > can be used to test both the real and complex versions of the libraries. If > > > they used the specific types they could only be testing one or the other. > > > > > > Note there is no harm in writing applications with PetscScalar it is > > > just usually not needed. > > > > > > Barry > > > > > > > Correct me if anybody finds this conclusion is not justified. > > > > > > > > Cheers, > > > > Youjun > > > > > > > > > > > > > > > > On Sat, Aug 4, 2018 at 11:03 AM Smith, Barry F. > > > wrote: > > > > > > > > For a particular configuration (./configure --with-scalar-type= real > > > or complex) the PETSc objects, such as vectors and matrices either contain > > > real values or complex values. In the same running code it is not possible > > > to have some vectors with real numbers and some vectors with complex > > > numbers. > > > > > > > > Depending on how you configure PETSc ./configure --with-scalar-type= > > > real or complex the variable name PetscScalar becomes either PetscReal or > > > PetscComplex. PETSc code is written with PetscScalar so we can reconfigure > > > the same source code and have it work with real numbers or complex. > > > > > > > > For users who just work with real numbers you can simply use > > > PetscReal as your variable type. If working with just with complex numbers > > > you can use PetscComplex. If you want to sometimes configure with real > > > numbers and sometimes configure with complex (which is not common) you use > > > PetscScalar. > > > > > > > > Barry > > > > > > > > > > > > > On Aug 4, 2018, at 11:39 AM, Youjun Hu wrote: > > > > > > > > > > Hi all, > > > > > > > > > > I am just wondering why PETSc introduces PetscScalar datatype in > > > addition to the PetscReal and PetscComplex. > > > > > Could someone help clarify the rationale behind this design? > > > > > I am primarily a Fortran guy. The additional datatype PetscScalar > > > seems to only confuse me rather than provide me any flexibility. > > > > > Cheers, > > > > > Youjun Hu > > > > > > > > > > > > > From youjunhu at gmail.com Sat Aug 4 16:43:36 2018 From: youjunhu at gmail.com (Youjun Hu) Date: Sat, 4 Aug 2018 15:43:36 -0600 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: References: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> <387682AF-213C-472A-9A01-C73567F487B6@mcs.anl.gov> Message-ID: Thank Satish. PetscFortranComplex works. I just want to distinguish between real and complex variables in my Fotran code, so I prefer to use PetscFortranComplex when a variables is complex. I began to learn petsc just several weeks ago. Another unusual thing I noticed is that petsc keywords are case-sensitive in Fotran codes, which breaks the convention that Fortran is case-insensitive. Correct me if I am wrong. Youjun On Sat, Aug 4, 2018 at 3:24 PM Satish Balay wrote: > For some reason it is PetscFortranComplex [on fortran side] > > I'm not sure I understand your logic for using PetscComplex and not > PetscScalar. > > We recommend using PetscScalar. You can choose not to follow our > recommendation. > > But we don't say 'PetscScalar' is the wrong thing for users [as you > appear to infer] > > Satish > > On Sat, 4 Aug 2018, Youjun Hu wrote: > > > I just tried to change PetscScalar to the specific datatype PetscComplex > in > > my Fortran code, but the compiler raised the following error: > > PetscComplex my_coeff > > Error: Unclassifiable statement at (1) > > > > It seems that the compiler does not know this datatype. > > > > My Petsc was configured with ./configure --with-scalar-type=complex > > --with-precision=double > > > > Before the modification, the code was complied successfully. > > Could someone help? > > > > Thanks, > > Youjun > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Sat Aug 4 16:48:29 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Sat, 4 Aug 2018 16:48:29 -0500 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: References: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> <387682AF-213C-472A-9A01-C73567F487B6@mcs.anl.gov> Message-ID: PETSc requires fortran preprocessing [or one could say C preprocessing if preprocessing is not part of any fortran standard - but most compilers support it] - and preprocessing is case sensitive. Satish On Sat, 4 Aug 2018, Youjun Hu wrote: > Thank Satish. > PetscFortranComplex works. > I just want to distinguish between real and complex variables in my Fotran > code, so I prefer to use PetscFortranComplex when a variables is complex. > I began to learn petsc just several weeks ago. > Another unusual thing I noticed is that petsc keywords are case-sensitive > in Fotran codes, which breaks the convention that Fortran is > case-insensitive. > Correct me if I am wrong. > > Youjun > > On Sat, Aug 4, 2018 at 3:24 PM Satish Balay wrote: > > > For some reason it is PetscFortranComplex [on fortran side] > > > > I'm not sure I understand your logic for using PetscComplex and not > > PetscScalar. > > > > We recommend using PetscScalar. You can choose not to follow our > > recommendation. > > > > But we don't say 'PetscScalar' is the wrong thing for users [as you > > appear to infer] > > > > Satish > > > > On Sat, 4 Aug 2018, Youjun Hu wrote: > > > > > I just tried to change PetscScalar to the specific datatype PetscComplex > > in > > > my Fortran code, but the compiler raised the following error: > > > PetscComplex my_coeff > > > Error: Unclassifiable statement at (1) > > > > > > It seems that the compiler does not know this datatype. > > > > > > My Petsc was configured with ./configure --with-scalar-type=complex > > > --with-precision=double > > > > > > Before the modification, the code was complied successfully. > > > Could someone help? > > > > > > Thanks, > > > Youjun > > > > > > > > > > > From jed at jedbrown.org Sat Aug 4 22:32:03 2018 From: jed at jedbrown.org (Jed Brown) Date: Sat, 04 Aug 2018 21:32:03 -0600 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: References: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> Message-ID: <87k1p5v68c.fsf@jedbrown.org> In application code, I would suggest using PetscScalar for solution/residual/matrix values any time real is sufficient, and PetscComplex is it must be complex. The reason is that you (or another user of your code) might later choose to couple your real-only solver into a multiphysics application that must simultaneously solve a complex-valued system. Youjun Hu writes: > Thank Barry for the clarification. > In summary, application code developers should choose the specific > datatypes (PetscReal and PetscComplex) rather than the more general > datatype PetscScalar > because application codes usually have fixed datatype and the flexibility > provided by PetscScalar is for PETSc library developers and usually not for > application developers. > If an application developer uses PetscScalar to declare a variable that is > intended by the developer to be complex and is assigned a complex value > later in the code and then used in, e.g., MatSetValues, but it happens > that petsc is configured with --with-scalar-type=real > then, it is not possible for this error to be detected at compiling time. > If the developer specify PetscComplex, then this inconsistency can be seen > by compilers and hopefully an error message can be raised during compiling. > > Conclusion: avoid using PetscScalar in application codes unless it is > absolutely needed (which is not common). The example application codes > provided in tutor folds of petsc often use PetscScalar, which is a little > misleading and should better be revised to use concrete datatypes. > Correct me if anybody finds this conclusion is not justified. > > Cheers, > Youjun > > > > On Sat, Aug 4, 2018 at 11:03 AM Smith, Barry F. wrote: > >> >> For a particular configuration (./configure --with-scalar-type= real or >> complex) the PETSc objects, such as vectors and matrices either contain >> real values or complex values. In the same running code it is not possible >> to have some vectors with real numbers and some vectors with complex >> numbers. >> >> Depending on how you configure PETSc ./configure --with-scalar-type= >> real or complex the variable name PetscScalar becomes either PetscReal or >> PetscComplex. PETSc code is written with PetscScalar so we can reconfigure >> the same source code and have it work with real numbers or complex. >> >> For users who just work with real numbers you can simply use PetscReal >> as your variable type. If working with just with complex numbers you can >> use PetscComplex. If you want to sometimes configure with real numbers and >> sometimes configure with complex (which is not common) you use PetscScalar. >> >> Barry >> >> >> > On Aug 4, 2018, at 11:39 AM, Youjun Hu wrote: >> > >> > Hi all, >> > >> > I am just wondering why PETSc introduces PetscScalar datatype in >> addition to the PetscReal and PetscComplex. >> > Could someone help clarify the rationale behind this design? >> > I am primarily a Fortran guy. The additional datatype PetscScalar seems >> to only confuse me rather than provide me any flexibility. >> > Cheers, >> > Youjun Hu >> >> From ysjosh.lo at gmail.com Sun Aug 5 21:38:19 2018 From: ysjosh.lo at gmail.com (Josh L) Date: Sun, 5 Aug 2018 21:38:19 -0500 Subject: [petsc-users] large number of iteration. Message-ID: Hi, I am using GRMES to solve the linear systems within Newton Raphson. I am using finite element method to solve fracture problem with phase field method.(the formulation gives symmetric but indefinite hessian so can't use CG) The total iteration number to solve one linear system is often very large( > 2000) even for a small sized problem(120K degree of freedom). I've tried different preconditioner, but it doesn't help a lot. I have checked my hessian and right hand side, and sure they are correct. I think it might stem from the great difference in element size(max/min=100) and damage stiffness around crack. Anyone has idea to reduce the number of iteration? Now, I get away with it by using LU, which is not ideal for large size problem (I will have to run it in the future) Thanks, Josh -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sun Aug 5 22:23:33 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Mon, 6 Aug 2018 03:23:33 +0000 Subject: [petsc-users] large number of iteration. In-Reply-To: References: Message-ID: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > Hi, > > I am using GRMES to solve the linear systems within Newton Raphson. > I am using finite element method to solve fracture problem with phase field method.(the formulation gives symmetric but indefinite hessian so can't use CG) What exact equations are you using for the phase field method? With the direct LU solver roughly how many iterations does your Newton's method take? Barry > > The total iteration number to solve one linear system is often very large( > 2000) even for a small sized problem(120K degree of freedom). I've tried different preconditioner, but it doesn't help a lot. I have checked my hessian and right hand side, and sure they are correct. > > I think it might stem from the great difference in element size(max/min=100) and damage stiffness around crack. > > Anyone has idea to reduce the number of iteration? > > Now, I get away with it by using LU, which is not ideal for large size problem (I will have to run it in the future) > > > Thanks, > Josh > From mbuerkle at web.de Mon Aug 6 00:27:13 2018 From: mbuerkle at web.de (Marius Buerkle) Date: Mon, 6 Aug 2018 07:27:13 +0200 Subject: [petsc-users] MatDenseGetArrayF90 In-Reply-To: <47A3CC67-846E-4D21-84E7-C542A7805D9A@anl.gov> References: <87k1p7wctu.fsf@jedbrown.org> <87efffwav1.fsf@jedbrown.org> <47A3CC67-846E-4D21-84E7-C542A7805D9A@anl.gov> Message-ID: An HTML attachment was scrubbed... URL: From michael.werner at dlr.de Mon Aug 6 07:38:14 2018 From: michael.werner at dlr.de (Michael Werner) Date: Mon, 6 Aug 2018 14:38:14 +0200 Subject: [petsc-users] SLEPc - Davidson-type solvers options Message-ID: Hello, I want to use a Davidson-type solver (probably jd) to find the eigenvalues with the smallest real part, but so far I'm strugglung to get them to converge. So I was hoping to get some advice on the various options available for those solvers. For my test case, I know the smallest eigenvalue is -0.04+0.71i (calculated with shift-and-invert and lu preconditioner). However, when I try to use jd or gd, the eigensolver never converges. After a few iterations, the "first unconverged value" is more or less as expected, but it fluctuates around the correct value, and the residual never drops below 1e-2. The best results so far were achieved with the following set of commandline options: -st_type precond -st_pc_type asm -st_sub_pc_type ilu -st_sub_pc_factor_levels 2 -st_ksp_max_it 15 -st_ksp_rtol 1e-2 -eps_type jd -eps_tol 1e-4 -eps_monitor -eps_nev 5 -eps_target -0.08 -eps_target_real -eps_harmonic_largest I also tried using more ksp iterations or different st_sub_pc_factor_levels. I also tried using eps_smallest_real instead of a target value, without any success. So far, I noticed that the extraction type had the largest influence. Only for eps_harmonic_largest could I observe any eigenvalues with negative real part, for all the other extraction types I only got eigenvalues with positive real parts. I also had a look at the available options for the Davidson solvers, but I couldn't find a good explanation for -- ____________________________________________________ Deutsches Zentrum f?r Luft- und Raumfahrt e.V. (DLR) Institut f?r Aerodynamik und Str?mungstechnik | Bunsenstr. 10 | 37073 G?ttingen Michael Werner Telefon 0551 709-2627 | Telefax 0551 709-2811 | Michael.Werner at dlr.de DLR.de From michael.werner at dlr.de Mon Aug 6 07:44:56 2018 From: michael.werner at dlr.de (Michael Werner) Date: Mon, 6 Aug 2018 14:44:56 +0200 Subject: [petsc-users] SLEPc - Davidson-type solvers options In-Reply-To: References: Message-ID: Michael Werner writes: > Hello, I want to use a Davidson-type solver (probably jd) to > find > the eigenvalues with the smallest real part, but so far I'm > strugglung to get them to converge. So I was hoping to get some > advice on the various options available for those solvers. > > For my test case, I know the smallest eigenvalue is -0.04+0.71i > (calculated with shift-and-invert and lu > preconditioner). However, > when I try to use jd or gd, the eigensolver never > converges. After > a few iterations, the "first unconverged value" is more or less > as > expected, but it fluctuates around the correct value, and the > residual never drops below 1e-2. The best results so far were > achieved with the following set of commandline options: > > -st_type precond -st_pc_type asm -st_sub_pc_type ilu > -st_sub_pc_factor_levels 2 -st_ksp_max_it 15 -st_ksp_rtol 1e-2 > -eps_type jd -eps_tol 1e-4 -eps_monitor -eps_nev 5 -eps_target > -0.08 -eps_target_real -eps_harmonic_largest > > I also tried using more ksp iterations or different > st_sub_pc_factor_levels. I also tried using eps_smallest_real > instead of a target value, without any success. So far, I > noticed > that the extraction type had the largest influence. Only for > eps_harmonic_largest could I observe any eigenvalues with > negative > real part, for all the other extraction types I only got > eigenvalues with positive real parts. > > I also had a look at the available options for the Davidson > solvers, but I couldn't find a good explanation for Sorry, I didn't mean to send it already. What I wanted to say: I also had a look at the available options for the Davidson solvers, but I couldn't find a good explanation for many of the additional options. Is there any recommendation to chose -eps_mpd or -eps_jd_minv? And can -eps_jd_plusk be used for GNHEP-type problems? I already had a look at the paper of E. Romero and J. E. Roman concerning the implementation of the Davidson-type solvers in SLEPc, but it didn't answer all my questions. Kind regards, Michael From jroman at dsic.upv.es Mon Aug 6 11:23:11 2018 From: jroman at dsic.upv.es (Jose E. Roman) Date: Mon, 6 Aug 2018 18:23:11 +0200 Subject: [petsc-users] SLEPc - Davidson-type solvers options In-Reply-To: References: Message-ID: <52783233-77AC-4733-A0B6-0ADB0885A915@dsic.upv.es> > El 6 ago 2018, a las 14:44, Michael Werner escribi?: > > > Michael Werner writes: > >> Hello, I want to use a Davidson-type solver (probably jd) to find the eigenvalues with the smallest real part, but so far I'm strugglung to get them to converge. So I was hoping to get some advice on the various options available for those solvers. >> >> For my test case, I know the smallest eigenvalue is -0.04+0.71i (calculated with shift-and-invert and lu preconditioner). However, when I try to use jd or gd, the eigensolver never converges. After a few iterations, the "first unconverged value" is more or less as expected, but it fluctuates around the correct value, and the residual never drops below 1e-2. The best results so far were achieved with the following set of commandline options: >> >> -st_type precond -st_pc_type asm -st_sub_pc_type ilu -st_sub_pc_factor_levels 2 -st_ksp_max_it 15 -st_ksp_rtol 1e-2 -eps_type jd -eps_tol 1e-4 -eps_monitor -eps_nev 5 -eps_target -0.08 -eps_target_real -eps_harmonic_largest >> >> I also tried using more ksp iterations or different st_sub_pc_factor_levels. I also tried using eps_smallest_real instead of a target value, without any success. So far, I noticed that the extraction type had the largest influence. Only for eps_harmonic_largest could I observe any eigenvalues with negative real part, for all the other extraction types I only got eigenvalues with positive real parts. >> >> I also had a look at the available options for the Davidson solvers, but I couldn't find a good explanation for > > Sorry, I didn't mean to send it already. What I wanted to say: > > I also had a look at the available options for the Davidson solvers, but I couldn't find a good explanation for many of the additional options. Is there any recommendation to chose -eps_mpd or -eps_jd_minv? And can -eps_jd_plusk be used for GNHEP-type problems? I already had a look at the paper of E. Romero and J. E. Roman concerning the implementation of the Davidson-type solvers in SLEPc, but it didn't answer all my questions. > > Kind regards, > Michael You may need to enforce more accuracy on the KSP. Try replacing -st_ksp_max_it 15 -st_ksp_rtol 1e-2 by -st_ksp_rtol 1e-5 Normally, you don't need to set the -eps_mpd parameter, except if many eigenvalues (nev) are requested. The parameter jd_minv controls how the restart is done, keeping more or less information from previous restarts - it may affect convergece, but not too much. And yes, jd_plusk can be used for GNHEP problems. Jose From dave.mayhem23 at gmail.com Mon Aug 6 12:06:24 2018 From: dave.mayhem23 at gmail.com (Dave May) Date: Mon, 6 Aug 2018 18:06:24 +0100 Subject: [petsc-users] memory corruption when using harmonic extraction with SLEPc In-Reply-To: <94f83099273e45879db063baf9eee516@uottawa.ca> References: <2aa8cc5756394b639a54bdbf9aa4f887@uottawa.ca> <94f83099273e45879db063baf9eee516@uottawa.ca> Message-ID: Please always use "reply-all" so that your messages go to the list. This is standard mailing list etiquette. It is important to preserve threading for people who find this discussion later and so that we do not waste our time re-answering the same questions that have already been answered in private side-conversations. You'll likely get an answer faster that way too. On 6 August 2018 at 17:17, Moritz Cygorek wrote: > Hi, > > > I have found that the memory corruption takes place at the end of the > first iteration or the beginning of the second iteration, i.e., at a time > where I expect the harmonic extraction part to do some calculations. > Where is the report from valgrind indicating the exact file/function/line where the problem occurred? > I've then played around with the command line options and I found that > harmonic extraction works when -eps_ncv is set to smaller values. > > I have the feeling that the memory needs to sustain this number of vectors > and the eigenvectors for all processes individually. If I run multiple > processes on a single computer, much more memory is required for storage > than when I only use a single process, eventually allocating all of the > available memory > > > Do you know if this behavior of the harmonic extraction routine > intended/necessary? > > > Regards, > Moritz > > > > > > > > ------------------------------ > *From:* Dave May > *Sent:* Friday, August 3, 2018 12:59:54 AM > *To:* Moritz Cygorek > *Cc:* petsc-users at mcs.anl.gov > *Subject:* Re: [petsc-users] memory corruption when using harmonic > extraction with SLEPc > > On Thu, 2 Aug 2018 at 21:32, Moritz Cygorek wrote: > >> Hi, >> >> >> I want to diagonalize a huge sparse matrix and I'm using the Kryov-Schur >> method with harmonic extraction (command line option -eps_harmonic ) >> implemented in SLEPc. >> >> >> I manually distribute a sparse matrix across several CPUs and everything >> works fine when: >> >> - I do _not_ use harmonic extraction >> >> - I use harmonic extraction on only a single CPU >> >> >> If I try do use harmonic extraction on multiple CPUs, I get a memory >> corruption. >> >> I'm not quite sure where to look at, but somewhere in the output, I find: >> >> >> >> [1]PETSC ERROR: PetscMallocValidate: error detected at >> PetscSignalHandlerDefault() line 145 in /home/applications/sources/ >> libraries/petsc-3.9.3/src/sys/error/signal.c >> [1]PETSC ERROR: Memory [id=0(9072)] at address 0x145bcd0 is corrupted >> (probably write past end of array) >> [1]PETSC ERROR: Memory originally allocated in DSAllocateWork_Private() >> line 74 in /home/applications/sources/libraries/slepc-3.9.2/src/sys/ >> classes/ds/interface/dspriv.c >> >> >> Now, I have the feeling that this might be a bug in SLEPc because, if I >> had messed up the matrix initialization and distribution, I should also get >> a memory corruption when I don't use harmonic extraction, right? >> > > Not necessarily > > >> Any suggestions what might be going on? >> > > Run your code through valgrind and make sure that your application code is > clean. See here > > http://www.mcs.anl.gov/petsc/documentation/faq.html#valgrind > > If errors are detected in your application code, fix them and see if the > slepc errors go away. If your code is valgrind clean, send through the > relevant chunk of the valgrind report indicating exactly where the error is > occurring > > Thanks, > Dave > > > >> Regards, >> >> Moritz >> >> >> >> >> >> >> >> -------------- next part -------------- An HTML attachment was scrubbed... URL: From ysjosh.lo at gmail.com Mon Aug 6 12:58:31 2018 From: ysjosh.lo at gmail.com (Josh L) Date: Mon, 6 Aug 2018 12:58:31 -0500 Subject: [petsc-users] large number of iteration. In-Reply-To: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> Message-ID: Hi Barry, (1) I am basically solving the equilibrium coupled with phase field equation: 1-D example u is displacement and c is phase-field parameter. equilibrium: (c^2)*E* (\Delta u) = 0 phase-field equation: 2*G_c*L*(\Delta c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 I solve the above 2 equations coupled. it is the formulation for quasi-static fracture problem, where G_c is the critical energy release rate and L is the length scale in phase-field method (both constant). The free energy I am using now is 1-D: \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c it is not convex w.r.t u and c simultaneously. (2) with an appropriate step size. Newton's method usually converges with 5 iteration, and I can see the quadratic convergence of Newton's method. Thanks, Josh 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > > > Hi, > > > > I am using GRMES to solve the linear systems within Newton Raphson. > > I am using finite element method to solve fracture problem with phase > field method.(the formulation gives symmetric but indefinite hessian so > can't use CG) > > What exact equations are you using for the phase field method? > > With the direct LU solver roughly how many iterations does your > Newton's method take? > > > Barry > > > > > The total iteration number to solve one linear system is often very > large( > 2000) even for a small sized problem(120K degree of freedom). I've > tried different preconditioner, but it doesn't help a lot. I have checked > my hessian and right hand side, and sure they are correct. > > > > I think it might stem from the great difference in element > size(max/min=100) and damage stiffness around crack. > > > > Anyone has idea to reduce the number of iteration? > > > > Now, I get away with it by using LU, which is not ideal for large size > problem (I will have to run it in the future) > > > > > > Thanks, > > Josh > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Mon Aug 6 15:40:42 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Mon, 6 Aug 2018 20:40:42 +0000 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> Message-ID: <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> Ok, I think you want to use PCFIELDSPLIT with two fields u and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for each field. Then try replacing the direct solvers LU with hypre BoomerAMG first one at a time. Let us know how it goes and we'll make additional suggestions, Barry > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > Hi Barry, > > (1) > I am basically solving the equilibrium coupled with phase field equation: > > 1-D example > u is displacement and c is phase-field parameter. > > equilibrium: (c^2)*E* (\Delta u) = 0 > > phase-field equation: 2*G_c*L*(\Delta c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 > > I solve the above 2 equations coupled. > it is the formulation for quasi-static fracture problem, where G_c is the critical energy release rate and L is the length scale in phase-field method (both constant). > > The free energy I am using now is > 1-D: > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > it is not convex w.r.t u and c simultaneously. > > (2) > > with an appropriate step size. Newton's method usually converges with 5 iteration, and I can see the quadratic convergence of Newton's method. > > > > > Thanks, > Josh > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > > > Hi, > > > > I am using GRMES to solve the linear systems within Newton Raphson. > > I am using finite element method to solve fracture problem with phase field method.(the formulation gives symmetric but indefinite hessian so can't use CG) > > What exact equations are you using for the phase field method? > > With the direct LU solver roughly how many iterations does your Newton's method take? > > > Barry > > > > > The total iteration number to solve one linear system is often very large( > 2000) even for a small sized problem(120K degree of freedom). I've tried different preconditioner, but it doesn't help a lot. I have checked my hessian and right hand side, and sure they are correct. > > > > I think it might stem from the great difference in element size(max/min=100) and damage stiffness around crack. > > > > Anyone has idea to reduce the number of iteration? > > > > Now, I get away with it by using LU, which is not ideal for large size problem (I will have to run it in the future) > > > > > > Thanks, > > Josh > > > > From michael.wick.1980 at gmail.com Mon Aug 6 16:06:22 2018 From: michael.wick.1980 at gmail.com (Mike Wick) Date: Mon, 6 Aug 2018 14:06:22 -0700 Subject: [petsc-users] nest matrix and the corresponding vector format Message-ID: Hi PETSc team: I have a question regarding the compatibility between the nest matrix and the vec object. My understanding is that one should create and use nest vectors when the matrix is in the nest form. In the tutorial example http://www.mcs.anl.gov/petsc/petsc-current/src/snes/examples/tutorials/ex70.c.html I noticed that the vectors are created as regular MPI vectors, with the local partition left for PETSC_DECIDE, in lines 171-173. I wander if the underlying structure of the vectors are compatible with the nest matrix. If not, will that create some unnecessary communication work? Look forward to your suggestions. Best, Mike -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Aug 6 16:10:31 2018 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 6 Aug 2018 17:10:31 -0400 Subject: [petsc-users] nest matrix and the corresponding vector format In-Reply-To: References: Message-ID: On Mon, Aug 6, 2018 at 5:06 PM Mike Wick wrote: > Hi PETSc team: > > I have a question regarding the compatibility between the nest matrix and > the vec object. My understanding is that one should create and use nest > vectors when the matrix is in the nest form. > > In the tutorial example > > http://www.mcs.anl.gov/petsc/petsc-current/src/snes/examples/tutorials/ex70.c.html > > I noticed that the vectors are created as regular MPI vectors, with the > local partition left for PETSC_DECIDE, in lines 171-173. I wander if the > underlying structure of the vectors are compatible with the nest matrix. If > not, will that create some unnecessary communication work? > > Look forward to your suggestions. > Nest matrices work with any vector. Thanks, Matt > Best, > > Mike > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From michael.werner at dlr.de Tue Aug 7 05:01:13 2018 From: michael.werner at dlr.de (Michael Werner) Date: Tue, 7 Aug 2018 12:01:13 +0200 Subject: [petsc-users] SLEPc - Davidson-type solvers options In-Reply-To: <52783233-77AC-4733-A0B6-0ADB0885A915@dsic.upv.es> References: <52783233-77AC-4733-A0B6-0ADB0885A915@dsic.upv.es> Message-ID: Thank you for your reply and your explanations, I'll try it with a higher ksp tolerance. I chose this low value, because in the SLEPc manual it is mentioned that the Davidson solvers often work better with lower tolerances than with higher tolerances. Is there also a way to improve convergence for the gd solver? As far as I know it doesn't use a ksp , so the only way I can think of to improve convergence would be using a higher quality preconditioner, right? Kind regards, Michael Jose E. Roman writes: >> El 6 ago 2018, a las 14:44, Michael Werner >> escribi?: >> >> >> Michael Werner writes: >> >>> Hello, I want to use a Davidson-type solver (probably jd) to >>> find the eigenvalues with the smallest real part, but so far >>> I'm strugglung to get them to converge. So I was hoping to get >>> some advice on the various options available for those >>> solvers. >>> >>> For my test case, I know the smallest eigenvalue is >>> -0.04+0.71i (calculated with shift-and-invert and lu >>> preconditioner). However, when I try to use jd or gd, the >>> eigensolver never converges. After a few iterations, the >>> "first unconverged value" is more or less as expected, but it >>> fluctuates around the correct value, and the residual never >>> drops below 1e-2. The best results so far were achieved with >>> the following set of commandline options: >>> >>> -st_type precond -st_pc_type asm -st_sub_pc_type ilu >>> -st_sub_pc_factor_levels 2 -st_ksp_max_it 15 -st_ksp_rtol 1e-2 >>> -eps_type jd -eps_tol 1e-4 -eps_monitor -eps_nev 5 -eps_target >>> -0.08 -eps_target_real -eps_harmonic_largest >>> >>> I also tried using more ksp iterations or different >>> st_sub_pc_factor_levels. I also tried using eps_smallest_real >>> instead of a target value, without any success. So far, I >>> noticed that the extraction type had the largest >>> influence. Only for eps_harmonic_largest could I observe any >>> eigenvalues with negative real part, for all the other >>> extraction types I only got eigenvalues with positive real >>> parts. >>> >>> I also had a look at the available options for the Davidson >>> solvers, but I couldn't find a good explanation for >> >> Sorry, I didn't mean to send it already. What I wanted to say: >> >> I also had a look at the available options for the Davidson >> solvers, but I couldn't find a good explanation for many of the >> additional options. Is there any recommendation to chose >> -eps_mpd or -eps_jd_minv? And can -eps_jd_plusk be used for >> GNHEP-type problems? I already had a look at the paper of >> E. Romero and J. E. Roman concerning the implementation of the >> Davidson-type solvers in SLEPc, but it didn't answer all my >> questions. >> >> Kind regards, >> Michael > > You may need to enforce more accuracy on the KSP. Try replacing > -st_ksp_max_it 15 -st_ksp_rtol 1e-2 > by > -st_ksp_rtol 1e-5 > > Normally, you don't need to set the -eps_mpd parameter, except > if many eigenvalues (nev) are requested. The parameter jd_minv > controls how the restart is done, keeping more or less > information from previous restarts - it may affect convergece, > but not too much. And yes, jd_plusk can be used for GNHEP > problems. > > Jose From rupp at iue.tuwien.ac.at Tue Aug 7 08:22:23 2018 From: rupp at iue.tuwien.ac.at (Karl Rupp) Date: Tue, 7 Aug 2018 08:22:23 -0500 Subject: [petsc-users] Why PETSc needs PetscScalar datatype? In-Reply-To: References: <43879027-4B7B-41AC-9E01-5E335C0445F1@anl.gov> <387682AF-213C-472A-9A01-C73567F487B6@mcs.anl.gov> Message-ID: <3f28a32f-fb23-24e8-af52-4cf77ee60eec@iue.tuwien.ac.at> Hi Youjun, PetscFortranComplex has been merged to our `master` development branch and is also available via the `maint` branch. It will be part of the next 3.9.x point release. Best regards, Karli On 08/04/2018 04:43 PM, Youjun Hu wrote: > Thank Satish. > PetscFortranComplex works. > I just want to distinguish between real and complex variables in my > Fotran code, so I prefer to use PetscFortranComplex when a variables is > complex. > I began to learn petsc just several weeks ago. > Another unusual thing I noticed is that petsc keywords are > case-sensitive in Fotran codes, which breaks the convention that Fortran > is case-insensitive. > Correct me if I am wrong. > > Youjun > > On Sat, Aug 4, 2018 at 3:24 PM Satish Balay > wrote: > > For some reason it is PetscFortranComplex [on fortran side] > > I'm not sure I understand your logic for using PetscComplex and not > PetscScalar. > > We recommend using PetscScalar. You can choose not to follow our > recommendation. > > But we don't say 'PetscScalar' is the wrong thing for users [as you > appear to infer] > > Satish > > On Sat, 4 Aug 2018, Youjun Hu wrote: > > > I just tried to change PetscScalar to the specific datatype > PetscComplex in > > my Fortran code, but the compiler raised the following error: > > PetscComplex? ?my_coeff > > Error: Unclassifiable statement at (1) > > > > It seems that the compiler does not know this datatype. > > > > My Petsc was configured with ./configure? ?--with-scalar-type=complex > > --with-precision=double > > > > Before the modification, the code was complied successfully. > > Could someone help? > > > > Thanks, > > Youjun > > > > > From kenneth.c.hall at duke.edu Tue Aug 7 09:42:26 2018 From: kenneth.c.hall at duke.edu (Kenneth Hall, SC.D.) Date: Tue, 7 Aug 2018 14:42:26 +0000 Subject: [petsc-users] Preconditioning with SLEPc Message-ID: <239685B6-1A12-405C-A568-E862B274A68F@duke.edu> Hello, I am new to SLEPc and Petsc, so I would appreciate any help I can get with my question. I have a large eigenvalue problem I am solving, based on the linearization of a nonlinear code. The eigenvalue problem takes the form A.x = lambda.B.x I can generate the matrix B explicitly, but I can only form products of A.x, and not A itself, so I use a shell matrix. I also have an iterative solver I could potentially use as a preconditioner. That is, I have an operator K^-1 where K^-1 \approx (A - sigma.B)^-1 But again, I don?t have K^-1 explicitly, rather I can form products of K^-1 with a vector, so I would need to use a shell matrix. I have had success with the un-preconditioned case, but can?t figure out how to do the preconditioned case. Any suggestions would be greatly appreciated. I work with Fortran. A code snippet with the un-preconditioned set-up follows. Thanks in advance. Kenneth Hall =============================================================== ! !.... initialize slepc call SlepcInitialize(PETSC_NULL_CHARACTER,ierr) ; if (ierr .ne. 0) then ; stop 'SlepcInitialize failed' ; end if ! !.... get size and rank of MPI process call MPI_Comm_size(PETSC_COMM_WORLD,sz ,ierr) ; CHKERRA(ierr) call MPI_Comm_rank(PETSC_COMM_WORLD,rank,ierr) ; CHKERRA(ierr) ! if (sz .ne. 1) then ; SETERRA(PETSC_COMM_SELF,1,'This is a uniprocessor example only!'); endif ! !.... get user options call PetscOptionsGetInt (PETSC_NULL_OPTIONS,PETSC_NULL_CHARACTER,'-n' ,n ,flg,ierr) ; CHKERRA(ierr) call PetscOptionsHasName(PETSC_NULL_OPTIONS,PETSC_NULL_CHARACTER,'-terse',terse,ierr) ; CHKERRA(ierr) ! !.... write out option list if (rank .eq. 0 ) then write(*,*) 'n = ',n end if ! !.... Register the matrix-vector subroutine for the operator that defines the eigensystem, Ax=kBx call MatCreateShell(PETSC_COMM_WORLD,n,n,n,n,PETSC_NULL_INTEGER,A,ierr) ; CHKERRA(ierr) call MatShellSetOperation(A,MATOP_MULT,my_matmul_A,ierr) ; CHKERRA(ierr) ! !.... set up B matrix call MatCreate(PETSC_COMM_WORLD,B,ierr) ; CHKERRA(ierr) call MatSetSizes(B,n,n,n,n,ierr) ; CHKERRA(ierr) call MatSetFromOptions(B,ierr) ; CHKERRA(ierr) call MatSetUp(B,ierr) ; CHKERRA(ierr) call My_Matrix_B(B,n) ! !.... set up eigenvectors call VecCreate(PETSC_COMM_WORLD,xr,ierr) ; CHKERRA(ierr) call VecSetSizes(xr,n,n,ierr) ; CHKERRA(ierr) call VecSetFromOptions(xr,ierr) ; CHKERRA(ierr) call VecSetUp(xr,ierr) ; CHKERRA(ierr) ! call VecCreate(PETSC_COMM_WORLD,xi,ierr) ; CHKERRA(ierr) call VecSetSizes(xi,n,n,ierr) ; CHKERRA(ierr) call VecSetFromOptions(xi,ierr) ; CHKERRA(ierr) call VecSetUp(xi,ierr) ; CHKERRA(ierr) ! !.... Create eigensolver context call EPSCreate(PETSC_COMM_WORLD,eps,ierr) ; CHKERRA(ierr) ! !.... Set operators. In this case, it is a generalized eigenvalue problem call EPSSetOperators(eps,A,B,ierr) ; CHKERRA(ierr) call EPSSetProblemType(eps,EPS_GNHEP,ierr) ; CHKERRA(ierr) ! !.... set default options call EPSSetType(eps,EPSKRYLOVSCHUR,ierr) ; CHKERRA(ierr) ! !.... set default eigenvalues to find call EPSSetWhichEigenpairs(eps,EPS_LARGEST_REAL,ierr) ; CHKERRA(ierr) ! !.... number of requested eigenvalues call EPSSetDimensions(eps,nev,PETSC_DEFAULT_INTEGER,PETSC_DEFAULT_INTEGER,ierr) ; CHKERRA(ierr) ! !.... set stopping criteria call EPSSetTolerances(eps,tol,maxit,ierr) ; CHKERRA(ierr) ! !.... set up monitors call PetscViewerAndFormatCreate(PETSC_VIEWER_STDOUT_WORLD,PETSC_VIEWER_DEFAULT,vf,ierr) ; CHKERRA(ierr) call EPSMonitorSet(eps,EPSMONITORFIRST,vf,PetscViewerAndFormatDestroy,ierr) ; CHKERRA(ierr) call SlepcConvMonitorCreate(PETSC_VIEWER_STDOUT_WORLD,PETSC_VIEWER_DEFAULT,ctx,ierr) ; CHKERRA(ierr) call EPSMonitorSet(eps,EPSMONITORCONVERGED,ctx,SlepcConvMonitorDestroy,ierr) ; CHKERRA(ierr) ! !.... Set solver parameters at runtime call EPSSetFromOptions(eps,ierr) ; CHKERRA(ierr) ! !.... Solve the eigensystem call EPSSolve(eps,ierr) ; CHKERRA(ierr) -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Tue Aug 7 09:54:54 2018 From: jroman at dsic.upv.es (Jose E. Roman) Date: Tue, 7 Aug 2018 16:54:54 +0200 Subject: [petsc-users] SLEPc - Davidson-type solvers options In-Reply-To: References: <52783233-77AC-4733-A0B6-0ADB0885A915@dsic.upv.es> Message-ID: <8C22E5D5-8F69-43E9-A763-8829A8A7377D@dsic.upv.es> > El 7 ago 2018, a las 12:01, Michael Werner escribi?: > > Thank you for your reply and your explanations, I'll try it with a higher ksp tolerance. I chose this low value, because in the SLEPc manual it is mentioned that the Davidson solvers often work better with lower tolerances than with higher tolerances. > > Is there also a way to improve convergence for the gd solver? As far as I know it doesn't use a ksp , so the only way I can think of to improve convergence would be using a higher quality preconditioner, right? Yes, but "not too good". For instance an exact LU decomposition as a preconditioner may lead to stagnation in GD. Jose > > Kind regards, > Michael > > Jose E. Roman writes: > >>> El 6 ago 2018, a las 14:44, Michael Werner escribi?: >>> Michael Werner writes: >>>> Hello, I want to use a Davidson-type solver (probably jd) to find the eigenvalues with the smallest real part, but so far I'm strugglung to get them to converge. So I was hoping to get some advice on the various options available for those solvers. >>>> For my test case, I know the smallest eigenvalue is -0.04+0.71i (calculated with shift-and-invert and lu preconditioner). However, when I try to use jd or gd, the eigensolver never converges. After a few iterations, the "first unconverged value" is more or less as expected, but it fluctuates around the correct value, and the residual never drops below 1e-2. The best results so far were achieved with the following set of commandline options: >>>> -st_type precond -st_pc_type asm -st_sub_pc_type ilu -st_sub_pc_factor_levels 2 -st_ksp_max_it 15 -st_ksp_rtol 1e-2 -eps_type jd -eps_tol 1e-4 -eps_monitor -eps_nev 5 -eps_target -0.08 -eps_target_real -eps_harmonic_largest >>>> I also tried using more ksp iterations or different st_sub_pc_factor_levels. I also tried using eps_smallest_real instead of a target value, without any success. So far, I noticed that the extraction type had the largest influence. Only for eps_harmonic_largest could I observe any eigenvalues with negative real part, for all the other extraction types I only got eigenvalues with positive real parts. >>>> I also had a look at the available options for the Davidson solvers, but I couldn't find a good explanation for >>> Sorry, I didn't mean to send it already. What I wanted to say: >>> I also had a look at the available options for the Davidson solvers, but I couldn't find a good explanation for many of the additional options. Is there any recommendation to chose -eps_mpd or -eps_jd_minv? And can -eps_jd_plusk be used for GNHEP-type problems? I already had a look at the paper of E. Romero and J. E. Roman concerning the implementation of the Davidson-type solvers in SLEPc, but it didn't answer all my questions. >>> Kind regards, >>> Michael >> >> You may need to enforce more accuracy on the KSP. Try replacing >> -st_ksp_max_it 15 -st_ksp_rtol 1e-2 by >> -st_ksp_rtol 1e-5 >> >> Normally, you don't need to set the -eps_mpd parameter, except if many eigenvalues (nev) are requested. The parameter jd_minv controls how the restart is done, keeping more or less information from previous restarts - it may affect convergece, but not too much. And yes, jd_plusk can be used for GNHEP problems. >> >> Jose From jroman at dsic.upv.es Tue Aug 7 10:13:37 2018 From: jroman at dsic.upv.es (Jose E. Roman) Date: Tue, 7 Aug 2018 17:13:37 +0200 Subject: [petsc-users] Preconditioning with SLEPc In-Reply-To: <239685B6-1A12-405C-A568-E862B274A68F@duke.edu> References: <239685B6-1A12-405C-A568-E862B274A68F@duke.edu> Message-ID: <155492DE-E5A0-488C-BB28-36FB67732BD7@dsic.upv.es> Currently there is no straightforward way to do this in SLEPc. For a preconditioned eigensolver such as JD you could use this: http://slepc.upv.es/documentation/current/docs/manualpages/ST/STPrecondSetMatForPC.html in combination with pc=PCMAT. For a Krylov solver you will have to do something like this: call EPSSetWhichEigenpairs(eps,EPS_TARGET_REAL,ierr);CHKERRA(ierr) call EPSSetTarget(eps,sigma,ierr);CHKERRA(ierr) call EPSGetST(eps,st,ierr);CHKERRA(ierr) call STSetType(st,STSINVERT,ierr);CHKERRA(ierr) call STGetKSP(st,ksp,ierr);CHKERRA(ierr) call KSPGetPC(ksp,pc,ierr);CHKERRA(ierr) call KSPSetType(ksp,KSPBCGS,ierr);CHKERRA(ierr) call PCSetType(pc,PCNONE,ierr);CHKERRA(ierr) ! dummy preconditioner ! provide the preconditioner matrix after setup call EPSSetUp(eps,ierr);CHKERRA(ierr) call PCSetOperators(pc,PETSC_NULL_MAT,my_matmul_K,ierr);CHKERRA(ierr) call PCSetType(pc,PCMAT,ierr);CHKERRA(ierr) We may change the interface in future versions so that this can be done in a more natural way. Jose > El 7 ago 2018, a las 16:42, Kenneth Hall, SC.D. escribi?: > > Hello, > > I am new to SLEPc and Petsc, so I would appreciate any help I can get with my question. I have a large eigenvalue problem I am solving, based on the linearization of a nonlinear code. The eigenvalue problem takes the form > > A.x = lambda.B.x > > I can generate the matrix B explicitly, but I can only form products of A.x, and not A itself, so I use a shell matrix. I also have an iterative solver I could potentially use as a preconditioner. That is, I have an operator K^-1 where > > K^-1 \approx (A - sigma.B)^-1 > > But again, I don?t have K^-1 explicitly, rather I can form products of K^-1 with a vector, so I would need to use a shell matrix. > > I have had success with the un-preconditioned case, but can?t figure out how to do the preconditioned case. Any suggestions would be greatly appreciated. I work with Fortran. A code snippet with the un-preconditioned set-up follows. > > Thanks in advance. > Kenneth Hall > > > =============================================================== > > ! > !.... initialize slepc > call SlepcInitialize(PETSC_NULL_CHARACTER,ierr) ; if (ierr .ne. 0) then ; stop 'SlepcInitialize failed' ; end if > ! > !.... get size and rank of MPI process > call MPI_Comm_size(PETSC_COMM_WORLD,sz ,ierr) ; CHKERRA(ierr) > call MPI_Comm_rank(PETSC_COMM_WORLD,rank,ierr) ; CHKERRA(ierr) > ! > if (sz .ne. 1) then ; SETERRA(PETSC_COMM_SELF,1,'This is a uniprocessor example only!'); endif > ! > !.... get user options > call PetscOptionsGetInt (PETSC_NULL_OPTIONS,PETSC_NULL_CHARACTER,'-n' ,n ,flg,ierr) ; CHKERRA(ierr) > call PetscOptionsHasName(PETSC_NULL_OPTIONS,PETSC_NULL_CHARACTER,'-terse',terse,ierr) ; CHKERRA(ierr) > ! > !.... write out option list > if (rank .eq. 0 ) then > write(*,*) 'n = ',n > end if > ! > !.... Register the matrix-vector subroutine for the operator that defines the eigensystem, Ax=kBx > call MatCreateShell(PETSC_COMM_WORLD,n,n,n,n,PETSC_NULL_INTEGER,A,ierr) ; CHKERRA(ierr) > call MatShellSetOperation(A,MATOP_MULT,my_matmul_A,ierr) ; CHKERRA(ierr) > ! > !.... set up B matrix > call MatCreate(PETSC_COMM_WORLD,B,ierr) ; CHKERRA(ierr) > call MatSetSizes(B,n,n,n,n,ierr) ; CHKERRA(ierr) > call MatSetFromOptions(B,ierr) ; CHKERRA(ierr) > call MatSetUp(B,ierr) ; CHKERRA(ierr) > call My_Matrix_B(B,n) > ! > !.... set up eigenvectors > call VecCreate(PETSC_COMM_WORLD,xr,ierr) ; CHKERRA(ierr) > call VecSetSizes(xr,n,n,ierr) ; CHKERRA(ierr) > call VecSetFromOptions(xr,ierr) ; CHKERRA(ierr) > call VecSetUp(xr,ierr) ; CHKERRA(ierr) > ! > call VecCreate(PETSC_COMM_WORLD,xi,ierr) ; CHKERRA(ierr) > call VecSetSizes(xi,n,n,ierr) ; CHKERRA(ierr) > call VecSetFromOptions(xi,ierr) ; CHKERRA(ierr) > call VecSetUp(xi,ierr) ; CHKERRA(ierr) > ! > !.... Create eigensolver context > call EPSCreate(PETSC_COMM_WORLD,eps,ierr) ; CHKERRA(ierr) > ! > !.... Set operators. In this case, it is a generalized eigenvalue problem > call EPSSetOperators(eps,A,B,ierr) ; CHKERRA(ierr) > call EPSSetProblemType(eps,EPS_GNHEP,ierr) ; CHKERRA(ierr) > ! > !.... set default options > call EPSSetType(eps,EPSKRYLOVSCHUR,ierr) ; CHKERRA(ierr) > ! > !.... set default eigenvalues to find > call EPSSetWhichEigenpairs(eps,EPS_LARGEST_REAL,ierr) ; CHKERRA(ierr) > ! > !.... number of requested eigenvalues > call EPSSetDimensions(eps,nev,PETSC_DEFAULT_INTEGER,PETSC_DEFAULT_INTEGER,ierr) ; CHKERRA(ierr) > ! > !.... set stopping criteria > call EPSSetTolerances(eps,tol,maxit,ierr) ; CHKERRA(ierr) > ! > !.... set up monitors > call PetscViewerAndFormatCreate(PETSC_VIEWER_STDOUT_WORLD,PETSC_VIEWER_DEFAULT,vf,ierr) ; CHKERRA(ierr) > call EPSMonitorSet(eps,EPSMONITORFIRST,vf,PetscViewerAndFormatDestroy,ierr) ; CHKERRA(ierr) > call SlepcConvMonitorCreate(PETSC_VIEWER_STDOUT_WORLD,PETSC_VIEWER_DEFAULT,ctx,ierr) ; CHKERRA(ierr) > call EPSMonitorSet(eps,EPSMONITORCONVERGED,ctx,SlepcConvMonitorDestroy,ierr) ; CHKERRA(ierr) > ! > !.... Set solver parameters at runtime > call EPSSetFromOptions(eps,ierr) ; CHKERRA(ierr) > ! > !.... Solve the eigensystem > call EPSSolve(eps,ierr) ; CHKERRA(ierr) > From kenneth.c.hall at duke.edu Tue Aug 7 11:31:36 2018 From: kenneth.c.hall at duke.edu (Kenneth Hall, SC.D.) Date: Tue, 7 Aug 2018 16:31:36 +0000 Subject: [petsc-users] Preconditioning with SLEPc In-Reply-To: <155492DE-E5A0-488C-BB28-36FB67732BD7@dsic.upv.es> References: <239685B6-1A12-405C-A568-E862B274A68F@duke.edu> <155492DE-E5A0-488C-BB28-36FB67732BD7@dsic.upv.es> Message-ID: <38FF40B4-787B-42EA-B2AB-913C1A4B822E@duke.edu> Jose, Thank you very much for the quick response. I will try the approach for the Krylov solver. Kenneth. _________________________________________________________________ Kenneth C. Hall On Aug 7, 2018, at 11:13 AM, Jose E. Roman > wrote: Currently there is no straightforward way to do this in SLEPc. For a preconditioned eigensolver such as JD you could use this: https://urldefense.proofpoint.com/v2/url?u=http-3A__slepc.upv.es_documentation_current_docs_manualpages_ST_STPrecondSetMatForPC.html&d=DwIFaQ&c=imBPVzF25OnBgGmVOlcsiEgHoG1i6YHLR0Sj_gZ4adc&r=HM_IVChvU7XXVyLZB9xFCbw5_4LZNuzGEpVw5dUCyyo&m=L-kD1fTipDH_5BEC-T3FTfZKFQBUO6_ymvkpAiFfe38&s=kZTO6rmsUygc5qVZm5IkYMfjEMPVXloxoE0xi16ccUQ&e= in combination with pc=PCMAT. For a Krylov solver you will have to do something like this: call EPSSetWhichEigenpairs(eps,EPS_TARGET_REAL,ierr);CHKERRA(ierr) call EPSSetTarget(eps,sigma,ierr);CHKERRA(ierr) call EPSGetST(eps,st,ierr);CHKERRA(ierr) call STSetType(st,STSINVERT,ierr);CHKERRA(ierr) call STGetKSP(st,ksp,ierr);CHKERRA(ierr) call KSPGetPC(ksp,pc,ierr);CHKERRA(ierr) call KSPSetType(ksp,KSPBCGS,ierr);CHKERRA(ierr) call PCSetType(pc,PCNONE,ierr);CHKERRA(ierr) ! dummy preconditioner ! provide the preconditioner matrix after setup call EPSSetUp(eps,ierr);CHKERRA(ierr) call PCSetOperators(pc,PETSC_NULL_MAT,my_matmul_K,ierr);CHKERRA(ierr) call PCSetType(pc,PCMAT,ierr);CHKERRA(ierr) We may change the interface in future versions so that this can be done in a more natural way. Jose El 7 ago 2018, a las 16:42, Kenneth Hall, SC.D. escribi?: Hello, I am new to SLEPc and Petsc, so I would appreciate any help I can get with my question. I have a large eigenvalue problem I am solving, based on the linearization of a nonlinear code. The eigenvalue problem takes the form A.x = lambda.B.x I can generate the matrix B explicitly, but I can only form products of A.x, and not A itself, so I use a shell matrix. I also have an iterative solver I could potentially use as a preconditioner. That is, I have an operator K^-1 where K^-1 \approx (A - sigma.B)^-1 But again, I don?t have K^-1 explicitly, rather I can form products of K^-1 with a vector, so I would need to use a shell matrix. I have had success with the un-preconditioned case, but can?t figure out how to do the preconditioned case. Any suggestions would be greatly appreciated. I work with Fortran. A code snippet with the un-preconditioned set-up follows. Thanks in advance. Kenneth Hall =============================================================== ! !.... initialize slepc call SlepcInitialize(PETSC_NULL_CHARACTER,ierr) ; if (ierr .ne. 0) then ; stop 'SlepcInitialize failed' ; end if ! !.... get size and rank of MPI process call MPI_Comm_size(PETSC_COMM_WORLD,sz ,ierr) ; CHKERRA(ierr) call MPI_Comm_rank(PETSC_COMM_WORLD,rank,ierr) ; CHKERRA(ierr) ! if (sz .ne. 1) then ; SETERRA(PETSC_COMM_SELF,1,'This is a uniprocessor example only!'); endif ! !.... get user options call PetscOptionsGetInt (PETSC_NULL_OPTIONS,PETSC_NULL_CHARACTER,'-n' ,n ,flg,ierr) ; CHKERRA(ierr) call PetscOptionsHasName(PETSC_NULL_OPTIONS,PETSC_NULL_CHARACTER,'-terse',terse,ierr) ; CHKERRA(ierr) ! !.... write out option list if (rank .eq. 0 ) then write(*,*) 'n = ',n end if ! !.... Register the matrix-vector subroutine for the operator that defines the eigensystem, Ax=kBx call MatCreateShell(PETSC_COMM_WORLD,n,n,n,n,PETSC_NULL_INTEGER,A,ierr) ; CHKERRA(ierr) call MatShellSetOperation(A,MATOP_MULT,my_matmul_A,ierr) ; CHKERRA(ierr) ! !.... set up B matrix call MatCreate(PETSC_COMM_WORLD,B,ierr) ; CHKERRA(ierr) call MatSetSizes(B,n,n,n,n,ierr) ; CHKERRA(ierr) call MatSetFromOptions(B,ierr) ; CHKERRA(ierr) call MatSetUp(B,ierr) ; CHKERRA(ierr) call My_Matrix_B(B,n) ! !.... set up eigenvectors call VecCreate(PETSC_COMM_WORLD,xr,ierr) ; CHKERRA(ierr) call VecSetSizes(xr,n,n,ierr) ; CHKERRA(ierr) call VecSetFromOptions(xr,ierr) ; CHKERRA(ierr) call VecSetUp(xr,ierr) ; CHKERRA(ierr) ! call VecCreate(PETSC_COMM_WORLD,xi,ierr) ; CHKERRA(ierr) call VecSetSizes(xi,n,n,ierr) ; CHKERRA(ierr) call VecSetFromOptions(xi,ierr) ; CHKERRA(ierr) call VecSetUp(xi,ierr) ; CHKERRA(ierr) ! !.... Create eigensolver context call EPSCreate(PETSC_COMM_WORLD,eps,ierr) ; CHKERRA(ierr) ! !.... Set operators. In this case, it is a generalized eigenvalue problem call EPSSetOperators(eps,A,B,ierr) ; CHKERRA(ierr) call EPSSetProblemType(eps,EPS_GNHEP,ierr) ; CHKERRA(ierr) ! !.... set default options call EPSSetType(eps,EPSKRYLOVSCHUR,ierr) ; CHKERRA(ierr) ! !.... set default eigenvalues to find call EPSSetWhichEigenpairs(eps,EPS_LARGEST_REAL,ierr) ; CHKERRA(ierr) ! !.... number of requested eigenvalues call EPSSetDimensions(eps,nev,PETSC_DEFAULT_INTEGER,PETSC_DEFAULT_INTEGER,ierr) ; CHKERRA(ierr) ! !.... set stopping criteria call EPSSetTolerances(eps,tol,maxit,ierr) ; CHKERRA(ierr) ! !.... set up monitors call PetscViewerAndFormatCreate(PETSC_VIEWER_STDOUT_WORLD,PETSC_VIEWER_DEFAULT,vf,ierr) ; CHKERRA(ierr) call EPSMonitorSet(eps,EPSMONITORFIRST,vf,PetscViewerAndFormatDestroy,ierr) ; CHKERRA(ierr) call SlepcConvMonitorCreate(PETSC_VIEWER_STDOUT_WORLD,PETSC_VIEWER_DEFAULT,ctx,ierr) ; CHKERRA(ierr) call EPSMonitorSet(eps,EPSMONITORCONVERGED,ctx,SlepcConvMonitorDestroy,ierr) ; CHKERRA(ierr) ! !.... Set solver parameters at runtime call EPSSetFromOptions(eps,ierr) ; CHKERRA(ierr) ! !.... Solve the eigensystem call EPSSolve(eps,ierr) ; CHKERRA(ierr) -------------- next part -------------- An HTML attachment was scrubbed... URL: From mhbaghaei at mail.sjtu.edu.cn Wed Aug 8 04:25:30 2018 From: mhbaghaei at mail.sjtu.edu.cn (Amir) Date: Wed, 8 Aug 2018 17:25:30 +0800 Subject: [petsc-users] Setting TimeStep in TS Message-ID: <1533719731.local-02f520c6-9eab-v1.3.0-fd741eb7@getmailspring.com> Hi Trying to set the time step for next step, using TSPseudoSetVerifyTimeStep(), by TTE method. It seems we need to use the new solution at the next step. We can get that by TSSetPostEvaluate(). However, it is called before TimeStep routine. Is there any way that I can access to new solution, while I can set the the time step? Thanks for your great time. Amir -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 8 10:37:30 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 8 Aug 2018 15:37:30 +0000 Subject: [petsc-users] Setting TimeStep in TS In-Reply-To: <1533719731.local-02f520c6-9eab-v1.3.0-fd741eb7@getmailspring.com> References: <1533719731.local-02f520c6-9eab-v1.3.0-fd741eb7@getmailspring.com> Message-ID: <5C65183A-1EEC-49A0-8F1C-AB5F4BC79AA3@anl.gov> I don't understand. One of the arguments to your TSPseudoSetVerifyTimeStep() routine is the "update - latest solution vector" but you seem to want access to the "next" solution that has yet to be computed? There is no way to access that because it has not yet been computed and cannot be computed until the next time step has been decided on. Barry > On Aug 8, 2018, at 3:25 AM, Amir wrote: > > Hi > Trying to set the time step for next step, using TSPseudoSetVerifyTimeStep(), by TTE method. It seems we need to use the new solution at the next step. We can get that by TSSetPostEvaluate(). However, it is called before TimeStep routine. Is there any way that I can access to new solution, while I can set the the time step? > Thanks for your great time. > Amir > From kenneth.c.hall at duke.edu Wed Aug 8 10:50:48 2018 From: kenneth.c.hall at duke.edu (Kenneth Hall, SC.D.) Date: Wed, 8 Aug 2018 15:50:48 +0000 Subject: [petsc-users] Preconditioning with SLEPc In-Reply-To: <155492DE-E5A0-488C-BB28-36FB67732BD7@dsic.upv.es> References: <239685B6-1A12-405C-A568-E862B274A68F@duke.edu> <155492DE-E5A0-488C-BB28-36FB67732BD7@dsic.upv.es> Message-ID: <9CE123A5-44E9-4C26-876E-05484EC0AFAE@duke.edu> Roman, When I tried what you suggested, I get the following error: call PCSetOperators(pc,PETSC_NULL_MAT,my_matmul_k,ierr);CHKERRA(ierr) 1 Error: Invalid procedure argument at (1) make: *** [/Users/hall/git/Mustang/Mustang/build_dir/slepc_eigen2.o] Error 1 I assume this is because PCSetOperators is expecting a MAT type rather than a subroutine. I modified your code snippet using a shell matrix, with the result: call EPSSetWhichEigenpairs(eps,EPS_TARGET_REAL,ierr);CHKERRA(ierr) call EPSSetTarget(eps,sigma,ierr);CHKERRA(ierr) call EPSGetST(eps,st,ierr);CHKERRA(ierr) call STSetType(st,STSINVERT,ierr);CHKERRA(ierr) call STGetKSP(st,ksp,ierr);CHKERRA(ierr) call KSPGetPC(ksp,pc,ierr);CHKERRA(ierr) call KSPSetType(ksp,KSPBCGS,ierr);CHKERRA(ierr) call PCSetType(pc,PCNONE,ierr);CHKERRA(ierr) call EPSSetUp(eps,ierr);CHKERRA(ierr) ! begin modified code call MatCreateShell(PETSC_COMM_WORLD,n,n,n,n,PETSC_NULL_INTEGER,P,ierr) ; CHKERRA(ierr) call MatShellSetOperation(P,MATOP_MULT,my_matmul_k,ierr); CHKERRA(ierr) call PCSetOperators(pc,PETSC_NULL_MAT,P,ierr);CHKERRA(ierr) ! end modified code call PCSetType(pc,PCMAT,ierr);CHKERRA(ierr) Is this the correct thing to do here? Again, thank you for your help. Kenneth On Aug 7, 2018, at 11:13 AM, Jose E. Roman > wrote: Currently there is no straightforward way to do this in SLEPc. For a preconditioned eigensolver such as JD you could use this: https://urldefense.proofpoint.com/v2/url?u=http-3A__slepc.upv.es_documentation_current_docs_manualpages_ST_STPrecondSetMatForPC.html&d=DwIFaQ&c=imBPVzF25OnBgGmVOlcsiEgHoG1i6YHLR0Sj_gZ4adc&r=HM_IVChvU7XXVyLZB9xFCbw5_4LZNuzGEpVw5dUCyyo&m=L-kD1fTipDH_5BEC-T3FTfZKFQBUO6_ymvkpAiFfe38&s=kZTO6rmsUygc5qVZm5IkYMfjEMPVXloxoE0xi16ccUQ&e= in combination with pc=PCMAT. For a Krylov solver you will have to do something like this: call EPSSetWhichEigenpairs(eps,EPS_TARGET_REAL,ierr);CHKERRA(ierr) call EPSSetTarget(eps,sigma,ierr);CHKERRA(ierr) call EPSGetST(eps,st,ierr);CHKERRA(ierr) call STSetType(st,STSINVERT,ierr);CHKERRA(ierr) call STGetKSP(st,ksp,ierr);CHKERRA(ierr) call KSPGetPC(ksp,pc,ierr);CHKERRA(ierr) call KSPSetType(ksp,KSPBCGS,ierr);CHKERRA(ierr) call PCSetType(pc,PCNONE,ierr);CHKERRA(ierr) ! dummy preconditioner ! provide the preconditioner matrix after setup call EPSSetUp(eps,ierr);CHKERRA(ierr) call PCSetOperators(pc,PETSC_NULL_MAT,my_matmul_K,ierr);CHKERRA(ierr) call PCSetType(pc,PCMAT,ierr);CHKERRA(ierr) We may change the interface in future versions so that this can be done in a more natural way. Jose El 7 ago 2018, a las 16:42, Kenneth Hall, SC.D. escribi?: Hello, I am new to SLEPc and Petsc, so I would appreciate any help I can get with my question. I have a large eigenvalue problem I am solving, based on the linearization of a nonlinear code. The eigenvalue problem takes the form A.x = lambda.B.x I can generate the matrix B explicitly, but I can only form products of A.x, and not A itself, so I use a shell matrix. I also have an iterative solver I could potentially use as a preconditioner. That is, I have an operator K^-1 where K^-1 \approx (A - sigma.B)^-1 But again, I don?t have K^-1 explicitly, rather I can form products of K^-1 with a vector, so I would need to use a shell matrix. I have had success with the un-preconditioned case, but can?t figure out how to do the preconditioned case. Any suggestions would be greatly appreciated. I work with Fortran. A code snippet with the un-preconditioned set-up follows. Thanks in advance. Kenneth Hall =============================================================== ! !.... initialize slepc call SlepcInitialize(PETSC_NULL_CHARACTER,ierr) ; if (ierr .ne. 0) then ; stop 'SlepcInitialize failed' ; end if ! !.... get size and rank of MPI process call MPI_Comm_size(PETSC_COMM_WORLD,sz ,ierr) ; CHKERRA(ierr) call MPI_Comm_rank(PETSC_COMM_WORLD,rank,ierr) ; CHKERRA(ierr) ! if (sz .ne. 1) then ; SETERRA(PETSC_COMM_SELF,1,'This is a uniprocessor example only!'); endif ! !.... get user options call PetscOptionsGetInt (PETSC_NULL_OPTIONS,PETSC_NULL_CHARACTER,'-n' ,n ,flg,ierr) ; CHKERRA(ierr) call PetscOptionsHasName(PETSC_NULL_OPTIONS,PETSC_NULL_CHARACTER,'-terse',terse,ierr) ; CHKERRA(ierr) ! !.... write out option list if (rank .eq. 0 ) then write(*,*) 'n = ',n end if ! !.... Register the matrix-vector subroutine for the operator that defines the eigensystem, Ax=kBx call MatCreateShell(PETSC_COMM_WORLD,n,n,n,n,PETSC_NULL_INTEGER,A,ierr) ; CHKERRA(ierr) call MatShellSetOperation(A,MATOP_MULT,my_matmul_A,ierr) ; CHKERRA(ierr) ! !.... set up B matrix call MatCreate(PETSC_COMM_WORLD,B,ierr) ; CHKERRA(ierr) call MatSetSizes(B,n,n,n,n,ierr) ; CHKERRA(ierr) call MatSetFromOptions(B,ierr) ; CHKERRA(ierr) call MatSetUp(B,ierr) ; CHKERRA(ierr) call My_Matrix_B(B,n) ! !.... set up eigenvectors call VecCreate(PETSC_COMM_WORLD,xr,ierr) ; CHKERRA(ierr) call VecSetSizes(xr,n,n,ierr) ; CHKERRA(ierr) call VecSetFromOptions(xr,ierr) ; CHKERRA(ierr) call VecSetUp(xr,ierr) ; CHKERRA(ierr) ! call VecCreate(PETSC_COMM_WORLD,xi,ierr) ; CHKERRA(ierr) call VecSetSizes(xi,n,n,ierr) ; CHKERRA(ierr) call VecSetFromOptions(xi,ierr) ; CHKERRA(ierr) call VecSetUp(xi,ierr) ; CHKERRA(ierr) ! !.... Create eigensolver context call EPSCreate(PETSC_COMM_WORLD,eps,ierr) ; CHKERRA(ierr) ! !.... Set operators. In this case, it is a generalized eigenvalue problem call EPSSetOperators(eps,A,B,ierr) ; CHKERRA(ierr) call EPSSetProblemType(eps,EPS_GNHEP,ierr) ; CHKERRA(ierr) ! !.... set default options call EPSSetType(eps,EPSKRYLOVSCHUR,ierr) ; CHKERRA(ierr) ! !.... set default eigenvalues to find call EPSSetWhichEigenpairs(eps,EPS_LARGEST_REAL,ierr) ; CHKERRA(ierr) ! !.... number of requested eigenvalues call EPSSetDimensions(eps,nev,PETSC_DEFAULT_INTEGER,PETSC_DEFAULT_INTEGER,ierr) ; CHKERRA(ierr) ! !.... set stopping criteria call EPSSetTolerances(eps,tol,maxit,ierr) ; CHKERRA(ierr) ! !.... set up monitors call PetscViewerAndFormatCreate(PETSC_VIEWER_STDOUT_WORLD,PETSC_VIEWER_DEFAULT,vf,ierr) ; CHKERRA(ierr) call EPSMonitorSet(eps,EPSMONITORFIRST,vf,PetscViewerAndFormatDestroy,ierr) ; CHKERRA(ierr) call SlepcConvMonitorCreate(PETSC_VIEWER_STDOUT_WORLD,PETSC_VIEWER_DEFAULT,ctx,ierr) ; CHKERRA(ierr) call EPSMonitorSet(eps,EPSMONITORCONVERGED,ctx,SlepcConvMonitorDestroy,ierr) ; CHKERRA(ierr) ! !.... Set solver parameters at runtime call EPSSetFromOptions(eps,ierr) ; CHKERRA(ierr) ! !.... Solve the eigensystem call EPSSolve(eps,ierr) ; CHKERRA(ierr) -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 8 11:02:18 2018 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 8 Aug 2018 12:02:18 -0400 Subject: [petsc-users] Preconditioning with SLEPc In-Reply-To: <9CE123A5-44E9-4C26-876E-05484EC0AFAE@duke.edu> References: <239685B6-1A12-405C-A568-E862B274A68F@duke.edu> <155492DE-E5A0-488C-BB28-36FB67732BD7@dsic.upv.es> <9CE123A5-44E9-4C26-876E-05484EC0AFAE@duke.edu> Message-ID: On Wed, Aug 8, 2018 at 11:51 AM Kenneth Hall, SC.D. wrote: > Roman, > > When I tried what you suggested, I get the following error: > > call > PCSetOperators(pc,PETSC_NULL_MAT,my_matmul_k,ierr);CHKERRA(ierr) > 1 > Error: Invalid procedure argument at (1) > make: *** [/Users/hall/git/Mustang/Mustang/build_dir/slepc_eigen2.o] Error > 1 > > > I assume this is because PCSetOperators is expecting a MAT type rather > than a subroutine. I modified your code snippet using a shell matrix, with > the result: > > call EPSSetWhichEigenpairs(eps,EPS_TARGET_REAL,ierr);CHKERRA(ierr) > call EPSSetTarget(eps,sigma,ierr);CHKERRA(ierr) > call EPSGetST(eps,st,ierr);CHKERRA(ierr) > call STSetType(st,STSINVERT,ierr);CHKERRA(ierr) > call STGetKSP(st,ksp,ierr);CHKERRA(ierr) > call KSPGetPC(ksp,pc,ierr);CHKERRA(ierr) > call KSPSetType(ksp,KSPBCGS,ierr);CHKERRA(ierr) > call PCSetType(pc,PCNONE,ierr);CHKERRA(ierr) > call EPSSetUp(eps,ierr);CHKERRA(ierr) > > ! begin modified code > > > call MatCreateShell(PETSC_COMM_WORLD,n,n,n,n,PETSC_NULL_INTEGER,P,ierr) ; CHKERRA(ierr) > call MatShellSetOperation(P,MATOP_MULT,my_matmul_k,ierr); CHKERRA(ierr) > call PCSetOperators(pc,PETSC_NULL_MAT,P,ierr);CHKERRA(ierr) > > ! end modified code > > call PCSetType(pc,PCMAT,ierr);CHKERRA(ierr) > > > > Is this the correct thing to do here? > Yes. Matt > Again, thank you for your help. > Kenneth > > > On Aug 7, 2018, at 11:13 AM, Jose E. Roman wrote: > > Currently there is no straightforward way to do this in SLEPc. For a > preconditioned eigensolver such as JD you could use this: > https://urldefense.proofpoint.com/v2/url?u=http- > 3A__slepc.upv.es_documentation_current_docs_manualpages_ST_STPrecondSetMatForPC.html&d=DwIFaQ&c=imBPVzF25OnBgGmVOlcsiEgHoG1i6YHLR0Sj_gZ4adc&r=HM_IVChvU7XXVyLZB9xFCbw5_4LZNuzGEpVw5dUCyyo&m=L-kD1fTipDH_5BEC-T3FTfZKFQBUO6_ymvkpAiFfe38&s=kZTO6rmsUygc5qVZm5IkYMfjEMPVXloxoE0xi16ccUQ&e= > in combination with pc=PCMAT. > > For a Krylov solver you will have to do something like this: > > call EPSSetWhichEigenpairs(eps,EPS_TARGET_REAL,ierr);CHKERRA(ierr) > call EPSSetTarget(eps,sigma,ierr);CHKERRA(ierr) > call EPSGetST(eps,st,ierr);CHKERRA(ierr) > call STSetType(st,STSINVERT,ierr);CHKERRA(ierr) > call STGetKSP(st,ksp,ierr);CHKERRA(ierr) > call KSPGetPC(ksp,pc,ierr);CHKERRA(ierr) > call KSPSetType(ksp,KSPBCGS,ierr);CHKERRA(ierr) > call PCSetType(pc,PCNONE,ierr);CHKERRA(ierr) ! dummy preconditioner > > ! provide the preconditioner matrix after setup > call EPSSetUp(eps,ierr);CHKERRA(ierr) > call PCSetOperators(pc,PETSC_NULL_MAT,my_matmul_K,ierr);CHKERRA(ierr) > call PCSetType(pc,PCMAT,ierr);CHKERRA(ierr) > > We may change the interface in future versions so that this can be done in > a more natural way. > > Jose > > > El 7 ago 2018, a las 16:42, Kenneth Hall, SC.D. > escribi?: > > Hello, > > I am new to SLEPc and Petsc, so I would appreciate any help I can get with > my question. I have a large eigenvalue problem I am solving, based on the > linearization of a nonlinear code. The eigenvalue problem takes the form > > A.x = lambda.B.x > > I can generate the matrix B explicitly, but I can only form products of > A.x, and not A itself, so I use a shell matrix. I also have an iterative > solver I could potentially use as a preconditioner. That is, I have an > operator K^-1 where > > K^-1 \approx (A - sigma.B)^-1 > > But again, I don?t have K^-1 explicitly, rather I can form products of > K^-1 with a vector, so I would need to use a shell matrix. > > I have had success with the un-preconditioned case, but can?t figure out > how to do the preconditioned case. Any suggestions would be > greatly appreciated. I work with Fortran. A code snippet with the > un-preconditioned set-up follows. > > Thanks in advance. > Kenneth Hall > > > =============================================================== > > ! > !.... initialize slepc > call SlepcInitialize(PETSC_NULL_CHARACTER,ierr) ; if (ierr .ne. 0) > then ; stop 'SlepcInitialize failed' ; end if > ! > !.... get size and rank of MPI process > call MPI_Comm_size(PETSC_COMM_WORLD,sz ,ierr) > ; CHKERRA(ierr) > call MPI_Comm_rank(PETSC_COMM_WORLD,rank,ierr) > ; CHKERRA(ierr) > ! > if (sz .ne. 1) then ; SETERRA(PETSC_COMM_SELF,1,'This is a > uniprocessor example only!'); endif > ! > !.... get user options > call PetscOptionsGetInt (PETSC_NULL_OPTIONS,PETSC_NULL_CHARACTER,'-n' > ,n ,flg,ierr) ; CHKERRA(ierr) > call > PetscOptionsHasName(PETSC_NULL_OPTIONS,PETSC_NULL_CHARACTER,'-terse',terse,ierr) > ; CHKERRA(ierr) > ! > !.... write out option list > if (rank .eq. 0 ) then > write(*,*) 'n = ',n > end if > ! > !.... Register the matrix-vector subroutine for the operator that defines > the eigensystem, Ax=kBx > call > MatCreateShell(PETSC_COMM_WORLD,n,n,n,n,PETSC_NULL_INTEGER,A,ierr) > ; CHKERRA(ierr) > call MatShellSetOperation(A,MATOP_MULT,my_matmul_A,ierr) > ; CHKERRA(ierr) > ! > !.... set up B matrix > call MatCreate(PETSC_COMM_WORLD,B,ierr) > ; CHKERRA(ierr) > call MatSetSizes(B,n,n,n,n,ierr) > ; CHKERRA(ierr) > call MatSetFromOptions(B,ierr) > ; CHKERRA(ierr) > call MatSetUp(B,ierr) > ; CHKERRA(ierr) > call My_Matrix_B(B,n) > ! > !.... set up eigenvectors > call VecCreate(PETSC_COMM_WORLD,xr,ierr) > ; CHKERRA(ierr) > call VecSetSizes(xr,n,n,ierr) > ; CHKERRA(ierr) > call VecSetFromOptions(xr,ierr) > ; CHKERRA(ierr) > call VecSetUp(xr,ierr) > ; CHKERRA(ierr) > ! > call VecCreate(PETSC_COMM_WORLD,xi,ierr) > ; CHKERRA(ierr) > call VecSetSizes(xi,n,n,ierr) > ; CHKERRA(ierr) > call VecSetFromOptions(xi,ierr) > ; CHKERRA(ierr) > call VecSetUp(xi,ierr) > ; CHKERRA(ierr) > ! > !.... Create eigensolver context > call EPSCreate(PETSC_COMM_WORLD,eps,ierr) > ; CHKERRA(ierr) > ! > !.... Set operators. In this case, it is a generalized eigenvalue problem > call EPSSetOperators(eps,A,B,ierr) > ; CHKERRA(ierr) > call EPSSetProblemType(eps,EPS_GNHEP,ierr) > ; CHKERRA(ierr) > ! > !.... set default options > call EPSSetType(eps,EPSKRYLOVSCHUR,ierr) > ; CHKERRA(ierr) > ! > !.... set default eigenvalues to find > call EPSSetWhichEigenpairs(eps,EPS_LARGEST_REAL,ierr) > ; CHKERRA(ierr) > ! > !.... number of requested eigenvalues > call > EPSSetDimensions(eps,nev,PETSC_DEFAULT_INTEGER,PETSC_DEFAULT_INTEGER,ierr) > ; CHKERRA(ierr) > ! > !.... set stopping criteria > call EPSSetTolerances(eps,tol,maxit,ierr) > ; CHKERRA(ierr) > ! > !.... set up monitors > call > PetscViewerAndFormatCreate(PETSC_VIEWER_STDOUT_WORLD,PETSC_VIEWER_DEFAULT,vf,ierr) > ; CHKERRA(ierr) > call > EPSMonitorSet(eps,EPSMONITORFIRST,vf,PetscViewerAndFormatDestroy,ierr) > ; CHKERRA(ierr) > call > SlepcConvMonitorCreate(PETSC_VIEWER_STDOUT_WORLD,PETSC_VIEWER_DEFAULT,ctx,ierr) > ; CHKERRA(ierr) > call > EPSMonitorSet(eps,EPSMONITORCONVERGED,ctx,SlepcConvMonitorDestroy,ierr) > ; CHKERRA(ierr) > ! > !.... Set solver parameters at runtime > call EPSSetFromOptions(eps,ierr) > ; CHKERRA(ierr) > ! > !.... Solve the eigensystem > call EPSSolve(eps,ierr) > ; CHKERRA(ierr) > > > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From mhbaghaei at mail.sjtu.edu.cn Wed Aug 8 12:31:23 2018 From: mhbaghaei at mail.sjtu.edu.cn (Amir) Date: Thu, 9 Aug 2018 01:31:23 +0800 Subject: [petsc-users] Setting TimeStep in TS In-Reply-To: <5C65183A-1EEC-49A0-8F1C-AB5F4BC79AA3@anl.gov> References: <5C65183A-1EEC-49A0-8F1C-AB5F4BC79AA3@anl.gov> Message-ID: <1533746848.local-d6068718-27ab-v1.3.0-fd741eb7@getmailspring.com> You are right! It does have the "latest solution vector". But, I tried to use TSGetSolution() to get it but it seems it gives me the solution at the current time step, not the new solution. On Aug 8 2018, at 11:37 pm, Smith, Barry F. wrote: > > > I don't understand. One of the arguments to your TSPseudoSetVerifyTimeStep() routine is the "update - latest solution vector" but you seem to want access to the "next" solution that has yet to be computed? There is no way to access that because it has not yet been computed and cannot be computed until the next time step has been decided on. > Barry > > > On Aug 8, 2018, at 3:25 AM, Amir wrote: > > Hi > > Trying to set the time step for next step, using TSPseudoSetVerifyTimeStep(), by TTE method. It seems we need to use the new solution at the next step. We can get that by TSSetPostEvaluate(). However, it is called before TimeStep routine. Is there any way that I can access to new solution, while I can set the the time step? > > Thanks for your great time. > > Amir > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 8 12:54:01 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 8 Aug 2018 17:54:01 +0000 Subject: [petsc-users] Setting TimeStep in TS In-Reply-To: <1533746848.local-d6068718-27ab-v1.3.0-fd741eb7@getmailspring.com> References: <5C65183A-1EEC-49A0-8F1C-AB5F4BC79AA3@anl.gov> <1533746848.local-d6068718-27ab-v1.3.0-fd741eb7@getmailspring.com> Message-ID: > On Aug 8, 2018, at 11:31 AM, Amir wrote: > > You are right! It does have the "latest solution vector". But, I tried to use TSGetSolution() to get it but it seems it gives me the solution at the current time step, not the new solution. Yes, this is a feature, the new solution has not yet been updated which is why the solution is passed through the function interface for you to use. Is everything ok now (you can use the update function argument?) or is there still an issue for us to deal with? Barry > > On Aug 8 2018, at 11:37 pm, Smith, Barry F. wrote: > > > I don't understand. One of the arguments to your TSPseudoSetVerifyTimeStep() routine is the "update - latest solution vector" but you seem to want access to the "next" solution that has yet to be computed? There is no way to access that because it has not yet been computed and cannot be computed until the next time step has been decided on. > > Barry > > > On Aug 8, 2018, at 3:25 AM, Amir wrote: > > Hi > Trying to set the time step for next step, using TSPseudoSetVerifyTimeStep(), by TTE method. It seems we need to use the new solution at the next step. We can get that by TSSetPostEvaluate(). However, it is called before TimeStep routine. Is there any way that I can access to new solution, while I can set the the time step? > Thanks for your great time. > Amir > From mhbaghaei at mail.sjtu.edu.cn Wed Aug 8 13:18:05 2018 From: mhbaghaei at mail.sjtu.edu.cn (Amir) Date: Thu, 9 Aug 2018 02:18:05 +0800 Subject: [petsc-users] Setting TimeStep in TS In-Reply-To: References: Message-ID: <1533750879.local-f3a4555a-5374-v1.3.0-fd741eb7@getmailspring.com> At first, I used the TSGetSolution(), which gives me the current step solution. The argument is working and I check the function norm, which is what I used to tried to check. Very thankful for your quick reply. Amir On Aug 9 2018, at 1:54 am, Smith, Barry F. wrote: > > > > > On Aug 8, 2018, at 11:31 AM, Amir wrote: > > You are right! It does have the "latest solution vector". But, I tried to use TSGetSolution() to get it but it seems it gives me the solution at the current time step, not the new solution. > Yes, this is a feature, the new solution has not yet been updated which is why the solution is passed through the function interface for you to use. > Is everything ok now (you can use the update function argument?) or is there still an issue for us to deal with? > Barry > > > > > On Aug 8 2018, at 11:37 pm, Smith, Barry F. wrote: > > > > I don't understand. One of the arguments to your TSPseudoSetVerifyTimeStep() routine is the "update - latest solution vector" but you seem to want access to the "next" solution that has yet to be computed? There is no way to access that because it has not yet been computed and cannot be computed until the next time step has been decided on. > > Barry > > > > On Aug 8, 2018, at 3:25 AM, Amir wrote: > > Hi > > Trying to set the time step for next step, using TSPseudoSetVerifyTimeStep(), by TTE method. It seems we need to use the new solution at the next step. We can get that by TSSetPostEvaluate(). However, it is called before TimeStep routine. Is there any way that I can access to new solution, while I can set the the time step? > > Thanks for your great time. > > Amir > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 9 10:26:34 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 9 Aug 2018 15:26:34 +0000 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> Message-ID: <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> Ok, PCGAMG should work well for linear elasticity so on your reduced problem use -pc_type gamg then the group (Mark) will have specific suggestions for options. We want to see about 20 iterations for "well-behaved" linear elasticity problems. Barry > On Aug 8, 2018, at 5:48 PM, Josh L wrote: > > Hi Barry, > > Thanks for your help. > > I removed the phase field from my formulation by setting all corresponding degrees of freedom as Dirichlet boundary condition, so > my formulation becomes simply linear elastic. > Then I use CG for KSP and algebraic multigrid for precondiitoner. For a 150K dofs problem, the linear solver converges with 200s iteration(still too much I think), but with GMRES it again takes 2000 iteration to converge. with GMRES and default PC, it barely converges within 10K iteration. > > I will double check my hessian. below is the ksp monitor output from GMRES and gamg PC for first 500 iteration. > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 > > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : > > Ok, I think you want to use PCFIELDSPLIT with two fields u and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for each field. Then try replacing the direct solvers LU with hypre BoomerAMG first one at a time. > > Let us know how it goes and we'll make additional suggestions, > > Barry > > > > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > > > Hi Barry, > > > > (1) > > I am basically solving the equilibrium coupled with phase field equation: > > > > 1-D example > > u is displacement and c is phase-field parameter. > > > > equilibrium: (c^2)*E* (\Delta u) = 0 > > > > phase-field equation: 2*G_c*L*(\Delta c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 > > > > I solve the above 2 equations coupled. > > it is the formulation for quasi-static fracture problem, where G_c is the critical energy release rate and L is the length scale in phase-field method (both constant). > > > > The free energy I am using now is > > 1-D: > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > > > > it is not convex w.r.t u and c simultaneously. > > > > (2) > > > > with an appropriate step size. Newton's method usually converges with 5 iteration, and I can see the quadratic convergence of Newton's method. > > > > > > > > > > Thanks, > > Josh > > > > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > > > > > Hi, > > > > > > I am using GRMES to solve the linear systems within Newton Raphson. > > > I am using finite element method to solve fracture problem with phase field method.(the formulation gives symmetric but indefinite hessian so can't use CG) > > > > What exact equations are you using for the phase field method? > > > > With the direct LU solver roughly how many iterations does your Newton's method take? > > > > > > Barry > > > > > > > > The total iteration number to solve one linear system is often very large( > 2000) even for a small sized problem(120K degree of freedom). I've tried different preconditioner, but it doesn't help a lot. I have checked my hessian and right hand side, and sure they are correct. > > > > > > I think it might stem from the great difference in element size(max/min=100) and damage stiffness around crack. > > > > > > Anyone has idea to reduce the number of iteration? > > > > > > Now, I get away with it by using LU, which is not ideal for large size problem (I will have to run it in the future) > > > > > > > > > Thanks, > > > Josh > > > > > > > > > From mfadams at lbl.gov Thu Aug 9 12:55:57 2018 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 9 Aug 2018 13:55:57 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> Message-ID: Fracture mechanics problems are hard in my experience. You should try hypre and ML as well (you need to configure to download these packages). On Thu, Aug 9, 2018 at 11:27 AM Smith, Barry F. wrote: > > Ok, PCGAMG should work well for linear elasticity so on your reduced > problem use -pc_type gamg then the group (Mark) will have specific > suggestions for options. We want to see about 20 iterations for > "well-behaved" linear elasticity problems. > > Barry > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: > > > > Hi Barry, > > > > Thanks for your help. > > > > I removed the phase field from my formulation by setting all > corresponding degrees of freedom as Dirichlet boundary condition, so > > my formulation becomes simply linear elastic. > > Then I use CG for KSP and algebraic multigrid for precondiitoner. For a > 150K dofs problem, the linear solver converges with 200s iteration(still > too much I think), but with GMRES it again takes 2000 iteration to > converge. with GMRES and default PC, it barely converges within 10K > iteration. > > > > I will double check my hessian. below is the ksp monitor output from > GMRES and gamg PC for first 500 iteration. > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid norm > 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid norm > 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid norm > 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid norm > 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid norm > 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid norm > 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid norm > 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid norm > 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid norm > 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid norm > 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid norm > 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid norm > 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid norm > 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid norm > 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid norm > 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid norm > 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid norm > 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid norm > 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid norm > 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid norm > 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid norm > 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid norm > 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid norm > 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid norm > 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid norm > 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid norm > 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid norm > 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid norm > 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid norm > 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid norm > 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid norm > 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid norm > 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid norm > 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid norm > 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid norm > 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid norm > 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid norm > 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid norm > 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid norm > 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid norm > 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid norm > 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid norm > 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid norm > 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid norm > 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid norm > 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid norm > 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid norm > 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid norm > 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid norm > 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid norm > 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid norm > 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid norm > 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid norm > 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid norm > 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid norm > 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid norm > 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid norm > 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid norm > 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid norm > 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid norm > 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid norm > 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid norm > 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid norm > 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid norm > 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid norm > 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid norm > 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid norm > 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid norm > 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid norm > 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid norm > 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid norm > 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid norm > 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid norm > 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid norm > 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid norm > 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid norm > 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid norm > 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid norm > 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid norm > 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid norm > 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid norm > 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid norm > 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid norm > 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid norm > 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid norm > 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid norm > 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid norm > 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid norm > 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid norm > 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid norm > 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid norm > 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid norm > 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid norm > 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid norm > 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid norm > 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid norm > 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid norm > 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid norm > 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid norm > 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid norm > 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid norm > 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid norm > 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid norm > 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid norm > 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid norm > 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid norm > 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid norm > 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid norm > 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid norm > 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid norm > 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid norm > 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid norm > 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid norm > 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid norm > 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid norm > 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid norm > 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid norm > 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid norm > 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid norm > 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid norm > 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid norm > 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid norm > 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid norm > 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid norm > 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid norm > 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid norm > 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid norm > 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid norm > 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid norm > 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid norm > 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid norm > 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid norm > 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid norm > 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid norm > 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid norm > 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid norm > 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid norm > 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid norm > 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid norm > 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid norm > 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid norm > 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid norm > 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid norm > 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid norm > 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid norm > 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid norm > 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid norm > 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid norm > 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid norm > 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid norm > 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid norm > 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid norm > 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid norm > 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid norm > 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid norm > 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid norm > 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid norm > 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid norm > 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid norm > 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid norm > 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid norm > 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid norm > 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid norm > 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid norm > 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid norm > 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid norm > 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid norm > 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid norm > 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid norm > 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid norm > 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid norm > 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid norm > 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid norm > 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid norm > 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid norm > 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid norm > 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid norm > 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid norm > 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid norm > 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid norm > 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid norm > 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid norm > 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid norm > 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid norm > 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid norm > 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid norm > 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid norm > 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid norm > 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid norm > 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid norm > 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid norm > 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid norm > 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid norm > 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid norm > 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid norm > 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid norm > 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid norm > 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid norm > 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid norm > 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid norm > 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid norm > 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid norm > 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid norm > 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid norm > 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid norm > 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid norm > 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid norm > 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid norm > 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid norm > 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid norm > 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid norm > 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid norm > 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid norm > 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid norm > 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid norm > 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid norm > 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid norm > 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid norm > 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid norm > 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid norm > 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid norm > 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid norm > 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid norm > 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid norm > 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid norm > 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid norm > 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid norm > 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid norm > 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid norm > 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid norm > 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid norm > 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid norm > 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid norm > 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid norm > 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid norm > 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid norm > 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid norm > 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid norm > 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid norm > 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid norm > 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid norm > 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid norm > 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid norm > 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid norm > 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid norm > 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid norm > 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid norm > 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid norm > 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid norm > 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid norm > 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid norm > 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid norm > 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid norm > 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid norm > 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid norm > 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid norm > 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid norm > 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid norm > 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid norm > 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid norm > 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid norm > 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid norm > 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid norm > 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid norm > 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid norm > 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid norm > 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid norm > 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid norm > 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid norm > 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid norm > 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid norm > 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid norm > 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid norm > 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid norm > 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid norm > 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid norm > 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid norm > 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid norm > 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid norm > 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid norm > 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid norm > 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid norm > 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid norm > 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid norm > 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid norm > 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid norm > 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid norm > 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid norm > 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid norm > 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid norm > 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid norm > 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid norm > 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid norm > 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid norm > 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid norm > 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid norm > 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid norm > 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid norm > 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid norm > 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid norm > 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid norm > 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid norm > 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid norm > 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid norm > 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid norm > 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid norm > 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid norm > 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid norm > 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid norm > 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid norm > 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid norm > 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid norm > 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid norm > 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid norm > 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid norm > 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid norm > 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid norm > 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid norm > 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid norm > 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid norm > 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid norm > 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid norm > 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid norm > 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid norm > 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid norm > 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid norm > 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid norm > 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid norm > 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid norm > 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid norm > 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid norm > 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid norm > 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid norm > 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid norm > 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid norm > 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid norm > 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid norm > 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid norm > 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid norm > 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid norm > 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid norm > 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid norm > 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid norm > 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid norm > 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid norm > 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid norm > 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid norm > 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid norm > 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid norm > 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid norm > 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid norm > 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid norm > 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid norm > 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid norm > 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid norm > 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid norm > 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid norm > 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid norm > 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid norm > 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid norm > 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid norm > 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid norm > 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid norm > 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid norm > 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid norm > 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid norm > 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid norm > 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid norm > 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid norm > 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid norm > 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid norm > 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid norm > 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid norm > 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid norm > 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid norm > 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid norm > 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid norm > 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid norm > 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid norm > 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid norm > 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid norm > 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid norm > 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid norm > 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid norm > 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid norm > 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid norm > 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid norm > 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid norm > 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid norm > 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid norm > 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid norm > 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid norm > 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid norm > 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid norm > 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid norm > 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid norm > 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid norm > 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid norm > 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid norm > 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid norm > 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid norm > 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid norm > 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid norm > 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid norm > 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid norm > 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid norm > 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid norm > 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid norm > 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid norm > 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid norm > 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid norm > 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid norm > 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid norm > 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid norm > 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid norm > 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid norm > 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid norm > 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid norm > 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid norm > 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid norm > 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid norm > 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid norm > 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid norm > 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid norm > 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid norm > 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid norm > 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid norm > 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid norm > 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid norm > 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid norm > 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid norm > 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid norm > 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid norm > 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid norm > 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid norm > 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid norm > 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid norm > 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid norm > 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid norm > 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid norm > 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid norm > 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid norm > 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid norm > 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid norm > 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid norm > 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid norm > 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid norm > 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid norm > 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid norm > 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid norm > 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid norm > 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid norm > 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid norm > 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid norm > 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid norm > 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid norm > 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid norm > 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid norm > 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid norm > 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid norm > 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid norm > 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid norm > 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid norm > 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid norm > 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid norm > 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid norm > 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid norm > 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid norm > 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid norm > 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid norm > 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid norm > 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid norm > 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid norm > 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid norm > 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid norm > 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid norm > 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid norm > 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid norm > 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid norm > 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid norm > 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid norm > 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid norm > 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid norm > 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid norm > 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid norm > 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid norm > 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid norm > 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid norm > 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid norm > 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid norm > 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid norm > 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid norm > 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid norm > 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid norm > 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid norm > 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid norm > 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid norm > 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid norm > 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid norm > 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid norm > 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid norm > 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 > > > > > > > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u and c. > Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for > each field. Then try replacing the direct solvers LU with hypre BoomerAMG > first one at a time. > > > > Let us know how it goes and we'll make additional suggestions, > > > > Barry > > > > > > > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > > > > > Hi Barry, > > > > > > (1) > > > I am basically solving the equilibrium coupled with phase field > equation: > > > > > > 1-D example > > > u is displacement and c is phase-field parameter. > > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 > > > > > > phase-field equation: 2*G_c*L*(\Delta > c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 > > > > > > I solve the above 2 equations coupled. > > > it is the formulation for quasi-static fracture problem, where G_c is > the critical energy release rate and L is the length scale in phase-field > method (both constant). > > > > > > The free energy I am using now is > > > 1-D: > > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > > > > > > > it is not convex w.r.t u and c simultaneously. > > > > > > (2) > > > > > > with an appropriate step size. Newton's method usually converges with > 5 iteration, and I can see the quadratic convergence of Newton's method. > > > > > > > > > > > > > > > Thanks, > > > Josh > > > > > > > > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > > > > > > > Hi, > > > > > > > > I am using GRMES to solve the linear systems within Newton Raphson. > > > > I am using finite element method to solve fracture problem with > phase field method.(the formulation gives symmetric but indefinite hessian > so can't use CG) > > > > > > What exact equations are you using for the phase field method? > > > > > > With the direct LU solver roughly how many iterations does your > Newton's method take? > > > > > > > > > Barry > > > > > > > > > > > The total iteration number to solve one linear system is often very > large( > 2000) even for a small sized problem(120K degree of freedom). I've > tried different preconditioner, but it doesn't help a lot. I have checked > my hessian and right hand side, and sure they are correct. > > > > > > > > I think it might stem from the great difference in element > size(max/min=100) and damage stiffness around crack. > > > > > > > > Anyone has idea to reduce the number of iteration? > > > > > > > > Now, I get away with it by using LU, which is not ideal for large > size problem (I will have to run it in the future) > > > > > > > > > > > > Thanks, > > > > Josh > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 9 13:05:47 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 9 Aug 2018 18:05:47 +0000 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> Message-ID: Mark, We are only asking for the best GAMG options for linear elasticity? Barry > On Aug 9, 2018, at 11:55 AM, Mark Adams wrote: > > Fracture mechanics problems are hard in my experience. You should try hypre and ML as well (you need to configure to download these packages). > > On Thu, Aug 9, 2018 at 11:27 AM Smith, Barry F. wrote: > > Ok, PCGAMG should work well for linear elasticity so on your reduced problem use -pc_type gamg then the group (Mark) will have specific suggestions for options. We want to see about 20 iterations for "well-behaved" linear elasticity problems. > > Barry > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: > > > > Hi Barry, > > > > Thanks for your help. > > > > I removed the phase field from my formulation by setting all corresponding degrees of freedom as Dirichlet boundary condition, so > > my formulation becomes simply linear elastic. > > Then I use CG for KSP and algebraic multigrid for precondiitoner. For a 150K dofs problem, the linear solver converges with 200s iteration(still too much I think), but with GMRES it again takes 2000 iteration to converge. with GMRES and default PC, it barely converges within 10K iteration. > > > > I will double check my hessian. below is the ksp monitor output from GMRES and gamg PC for first 500 iteration. > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 > > > > > > > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for each field. Then try replacing the direct solvers LU with hypre BoomerAMG first one at a time. > > > > Let us know how it goes and we'll make additional suggestions, > > > > Barry > > > > > > > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > > > > > Hi Barry, > > > > > > (1) > > > I am basically solving the equilibrium coupled with phase field equation: > > > > > > 1-D example > > > u is displacement and c is phase-field parameter. > > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 > > > > > > phase-field equation: 2*G_c*L*(\Delta c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 > > > > > > I solve the above 2 equations coupled. > > > it is the formulation for quasi-static fracture problem, where G_c is the critical energy release rate and L is the length scale in phase-field method (both constant). > > > > > > The free energy I am using now is > > > 1-D: > > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > > > > > > > it is not convex w.r.t u and c simultaneously. > > > > > > (2) > > > > > > with an appropriate step size. Newton's method usually converges with 5 iteration, and I can see the quadratic convergence of Newton's method. > > > > > > > > > > > > > > > Thanks, > > > Josh > > > > > > > > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > > > > > > > Hi, > > > > > > > > I am using GRMES to solve the linear systems within Newton Raphson. > > > > I am using finite element method to solve fracture problem with phase field method.(the formulation gives symmetric but indefinite hessian so can't use CG) > > > > > > What exact equations are you using for the phase field method? > > > > > > With the direct LU solver roughly how many iterations does your Newton's method take? > > > > > > > > > Barry > > > > > > > > > > > The total iteration number to solve one linear system is often very large( > 2000) even for a small sized problem(120K degree of freedom). I've tried different preconditioner, but it doesn't help a lot. I have checked my hessian and right hand side, and sure they are correct. > > > > > > > > I think it might stem from the great difference in element size(max/min=100) and damage stiffness around crack. > > > > > > > > Anyone has idea to reduce the number of iteration? > > > > > > > > Now, I get away with it by using LU, which is not ideal for large size problem (I will have to run it in the future) > > > > > > > > > > > > Thanks, > > > > Josh > > > > > > > > > > > > > > > From daniel.kiefer at fau.de Thu Aug 9 14:07:06 2018 From: daniel.kiefer at fau.de (Daniel Kiefer) Date: Thu, 9 Aug 2018 21:07:06 +0200 Subject: [petsc-users] SLEPc4py function composition Message-ID: Dear SLEPc users, I am trying to solve a non-linear eigenvalue problem for which I need to use FNCombineSetChildren(). It seems to me that this function is not implemented in the Python bindings? Any information or help would be much appreciated. Best regards Daniel Kiefer -- Daniel Kiefer, M.Sc. Friedrich-Alexander-Universit?t Erlangen-N?rnberg (FAU) Lehrstuhl f?r Sensorik Paul-Gordan-Stra?e 3/5, 91052 Erlangen, Germany Tel. +49 9131 85 23134, Fax +49 9131 85 23133 University of Erlangen-Nuremberg (FAU) Chair of Sensor Technology From jroman at dsic.upv.es Thu Aug 9 14:36:08 2018 From: jroman at dsic.upv.es (Jose E. Roman) Date: Thu, 9 Aug 2018 21:36:08 +0200 Subject: [petsc-users] SLEPc4py function composition In-Reply-To: References: Message-ID: <96EA936E-F21D-448E-AD15-918B8BC81CD9@dsic.upv.es> I will add it in the next days and let you know. Jose > El 9 ago 2018, a las 21:07, Daniel Kiefer escribi?: > > Dear SLEPc users, > > I am trying to solve a non-linear eigenvalue problem for which I need to use FNCombineSetChildren(). It seems to me that this function is not implemented in the Python bindings? Any information or help would be much appreciated. > > Best regards > Daniel Kiefer > > -- > Daniel Kiefer, M.Sc. > Friedrich-Alexander-Universit?t Erlangen-N?rnberg (FAU) > Lehrstuhl f?r Sensorik > Paul-Gordan-Stra?e 3/5, 91052 Erlangen, Germany > Tel. +49 9131 85 23134, Fax +49 9131 85 23133 > > University of Erlangen-Nuremberg (FAU) > Chair of Sensor Technology > From bsmith at mcs.anl.gov Thu Aug 9 18:47:38 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 9 Aug 2018 23:47:38 +0000 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> Message-ID: > On Aug 9, 2018, at 3:03 PM, Josh L wrote: > > Hi Barry, > > I use the example ex49 of KSP(linear elasticity problem), and it's output of ksp monitor is the same as my reduced problem, so I think my code is correct , at least for the reduced problem. Are you using -pc_type gamg ? > > Within a Newton's method, several linear system(Ax=b) is solved, and b is the residual vector whose norm becomes smaller and smaller. > Should I change rtol for KSP ? since ||b|| is reducing, and converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is rarely satisfied ) > I observe that for the first linear solve in Newton's method, iterative solver converges with okay number of iteration > , but for the following linear solve, iterative solver takes more and more iterations. You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 Try also -ksp_pc_side right Barry > > > Thanks, > Josh > > > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : > > Ok, PCGAMG should work well for linear elasticity so on your reduced problem use -pc_type gamg then the group (Mark) will have specific suggestions for options. We want to see about 20 iterations for "well-behaved" linear elasticity problems. > > Barry > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: > > > > Hi Barry, > > > > Thanks for your help. > > > > I removed the phase field from my formulation by setting all corresponding degrees of freedom as Dirichlet boundary condition, so > > my formulation becomes simply linear elastic. > > Then I use CG for KSP and algebraic multigrid for precondiitoner. For a 150K dofs problem, the linear solver converges with 200s iteration(still too much I think), but with GMRES it again takes 2000 iteration to converge. with GMRES and default PC, it barely converges within 10K iteration. > > > > I will double check my hessian. below is the ksp monitor output from GMRES and gamg PC for first 500 iteration. > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 > > > > > > > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for each field. Then try replacing the direct solvers LU with hypre BoomerAMG first one at a time. > > > > Let us know how it goes and we'll make additional suggestions, > > > > Barry > > > > > > > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > > > > > Hi Barry, > > > > > > (1) > > > I am basically solving the equilibrium coupled with phase field equation: > > > > > > 1-D example > > > u is displacement and c is phase-field parameter. > > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 > > > > > > phase-field equation: 2*G_c*L*(\Delta c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 > > > > > > I solve the above 2 equations coupled. > > > it is the formulation for quasi-static fracture problem, where G_c is the critical energy release rate and L is the length scale in phase-field method (both constant). > > > > > > The free energy I am using now is > > > 1-D: > > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > > > > > > > it is not convex w.r.t u and c simultaneously. > > > > > > (2) > > > > > > with an appropriate step size. Newton's method usually converges with 5 iteration, and I can see the quadratic convergence of Newton's method. > > > > > > > > > > > > > > > Thanks, > > > Josh > > > > > > > > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > > > > > > > Hi, > > > > > > > > I am using GRMES to solve the linear systems within Newton Raphson. > > > > I am using finite element method to solve fracture problem with phase field method.(the formulation gives symmetric but indefinite hessian so can't use CG) > > > > > > What exact equations are you using for the phase field method? > > > > > > With the direct LU solver roughly how many iterations does your Newton's method take? > > > > > > > > > Barry > > > > > > > > > > > The total iteration number to solve one linear system is often very large( > 2000) even for a small sized problem(120K degree of freedom). I've tried different preconditioner, but it doesn't help a lot. I have checked my hessian and right hand side, and sure they are correct. > > > > > > > > I think it might stem from the great difference in element size(max/min=100) and damage stiffness around crack. > > > > > > > > Anyone has idea to reduce the number of iteration? > > > > > > > > Now, I get away with it by using LU, which is not ideal for large size problem (I will have to run it in the future) > > > > > > > > > > > > Thanks, > > > > Josh > > > > > > > > > > > > > > > > From ysjosh.lo at gmail.com Thu Aug 9 21:11:54 2018 From: ysjosh.lo at gmail.com (Josh L) Date: Thu, 9 Aug 2018 21:11:54 -0500 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> Message-ID: 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : > > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: > > > > Hi Barry, > > > > I use the example ex49 of KSP(linear elasticity problem), and it's > output of ksp monitor is the same as my reduced problem, so I think my code > is correct , at least for the reduced problem. > > Are you using -pc_type gamg ? > No, just with GMRES and default PC. strangely, with gamg, the final solution is still the same but ksp output becomes different between my code and petsc example. with -pc_type gamg, my code take 35 iteration and petsc example takes only 7. Thanks. > > > > > Within a Newton's method, several linear system(Ax=b) is solved, and b > is the residual vector whose norm becomes smaller and smaller. > > Should I change rtol for KSP ? since ||b|| is reducing, and converge > requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is rarely > satisfied ) > > I observe that for the first linear solve in Newton's method, iterative > solver converges with okay number of iteration > > , but for the following linear solve, iterative solver takes more and > more iterations. > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 > Try also -ksp_pc_side right > > > Barry > > > > > > > > Thanks, > > Josh > > > > > > > > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : > > > > Ok, PCGAMG should work well for linear elasticity so on your reduced > problem use -pc_type gamg then the group (Mark) will have specific > suggestions for options. We want to see about 20 iterations for > "well-behaved" linear elasticity problems. > > > > Barry > > > > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: > > > > > > Hi Barry, > > > > > > Thanks for your help. > > > > > > I removed the phase field from my formulation by setting all > corresponding degrees of freedom as Dirichlet boundary condition, so > > > my formulation becomes simply linear elastic. > > > Then I use CG for KSP and algebraic multigrid for precondiitoner. For > a 150K dofs problem, the linear solver converges with 200s iteration(still > too much I think), but with GMRES it again takes 2000 iteration to > converge. with GMRES and default PC, it barely converges within 10K > iteration. > > > > > > I will double check my hessian. below is the ksp monitor output from > GMRES and gamg PC for first 500 iteration. > > > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid norm > 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid norm > 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid norm > 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid norm > 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid norm > 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid norm > 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid norm > 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid norm > 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid norm > 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid norm > 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid norm > 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid norm > 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid norm > 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid norm > 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid norm > 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid norm > 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid norm > 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid norm > 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid norm > 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid norm > 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid norm > 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid norm > 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid norm > 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid norm > 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid norm > 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid norm > 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid norm > 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid norm > 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid norm > 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid norm > 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid norm > 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid norm > 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid norm > 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid norm > 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid norm > 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid norm > 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid norm > 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid norm > 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid norm > 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid norm > 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid norm > 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid norm > 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid norm > 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid norm > 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid norm > 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid norm > 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid norm > 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid norm > 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid norm > 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid norm > 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid norm > 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid norm > 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid norm > 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid norm > 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid norm > 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid norm > 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid norm > 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid norm > 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid norm > 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid norm > 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid norm > 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid norm > 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid norm > 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid norm > 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid norm > 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid norm > 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid norm > 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid norm > 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid norm > 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid norm > 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid norm > 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid norm > 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid norm > 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid norm > 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid norm > 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid norm > 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid norm > 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid norm > 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid norm > 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid norm > 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid norm > 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid norm > 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid norm > 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid norm > 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid norm > 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid norm > 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid norm > 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid norm > 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid norm > 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid norm > 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid norm > 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid norm > 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid norm > 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid norm > 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid norm > 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid norm > 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid norm > 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid norm > 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid norm > 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid norm > 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid norm > 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid norm > 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid norm > 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid norm > 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid norm > 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid norm > 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid norm > 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid norm > 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid norm > 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid norm > 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid norm > 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid norm > 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid norm > 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid norm > 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid norm > 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid norm > 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid norm > 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid norm > 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid norm > 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid norm > 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid norm > 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid norm > 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid norm > 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid norm > 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid norm > 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid norm > 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid norm > 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid norm > 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid norm > 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid norm > 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid norm > 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid norm > 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid norm > 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid norm > 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid norm > 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid norm > 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid norm > 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid norm > 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid norm > 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid norm > 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid norm > 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid norm > 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid norm > 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid norm > 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid norm > 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid norm > 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid norm > 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid norm > 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid norm > 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid norm > 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid norm > 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid norm > 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid norm > 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid norm > 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid norm > 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid norm > 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid norm > 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid norm > 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid norm > 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid norm > 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid norm > 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid norm > 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid norm > 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid norm > 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid norm > 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid norm > 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid norm > 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid norm > 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid norm > 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid norm > 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid norm > 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid norm > 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid norm > 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid norm > 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid norm > 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid norm > 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid norm > 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid norm > 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid norm > 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid norm > 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid norm > 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid norm > 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid norm > 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid norm > 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid norm > 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid norm > 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid norm > 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid norm > 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid norm > 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid norm > 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid norm > 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid norm > 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid norm > 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid norm > 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid norm > 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid norm > 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid norm > 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid norm > 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid norm > 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid norm > 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid norm > 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid norm > 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid norm > 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid norm > 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid norm > 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid norm > 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid norm > 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid norm > 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid norm > 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid norm > 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid norm > 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid norm > 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid norm > 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid norm > 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid norm > 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid norm > 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid norm > 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid norm > 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid norm > 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid norm > 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid norm > 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid norm > 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid norm > 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid norm > 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid norm > 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid norm > 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid norm > 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid norm > 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid norm > 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid norm > 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid norm > 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid norm > 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid norm > 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid norm > 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid norm > 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid norm > 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid norm > 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid norm > 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid norm > 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid norm > 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid norm > 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid norm > 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid norm > 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid norm > 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid norm > 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid norm > 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid norm > 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid norm > 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid norm > 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid norm > 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid norm > 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid norm > 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid norm > 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid norm > 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid norm > 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid norm > 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid norm > 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid norm > 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid norm > 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid norm > 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid norm > 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid norm > 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid norm > 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid norm > 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid norm > 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid norm > 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid norm > 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid norm > 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid norm > 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid norm > 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid norm > 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid norm > 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid norm > 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid norm > 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid norm > 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid norm > 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid norm > 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid norm > 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid norm > 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid norm > 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid norm > 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid norm > 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid norm > 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid norm > 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid norm > 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid norm > 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid norm > 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid norm > 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid norm > 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid norm > 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid norm > 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid norm > 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid norm > 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid norm > 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid norm > 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid norm > 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid norm > 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid norm > 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid norm > 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid norm > 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid norm > 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid norm > 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid norm > 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid norm > 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid norm > 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid norm > 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid norm > 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid norm > 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid norm > 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid norm > 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid norm > 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid norm > 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid norm > 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid norm > 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid norm > 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid norm > 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid norm > 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid norm > 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid norm > 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid norm > 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid norm > 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid norm > 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid norm > 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid norm > 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid norm > 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid norm > 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid norm > 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid norm > 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid norm > 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid norm > 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid norm > 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid norm > 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid norm > 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid norm > 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid norm > 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid norm > 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid norm > 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid norm > 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid norm > 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid norm > 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid norm > 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid norm > 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid norm > 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid norm > 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid norm > 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid norm > 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid norm > 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid norm > 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid norm > 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid norm > 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid norm > 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid norm > 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid norm > 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid norm > 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid norm > 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid norm > 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid norm > 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid norm > 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid norm > 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid norm > 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid norm > 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid norm > 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid norm > 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid norm > 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid norm > 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid norm > 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid norm > 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid norm > 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid norm > 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid norm > 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid norm > 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid norm > 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid norm > 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid norm > 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid norm > 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid norm > 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid norm > 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid norm > 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid norm > 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid norm > 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid norm > 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid norm > 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid norm > 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid norm > 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid norm > 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid norm > 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid norm > 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid norm > 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid norm > 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid norm > 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid norm > 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid norm > 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid norm > 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid norm > 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid norm > 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid norm > 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid norm > 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid norm > 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid norm > 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid norm > 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid norm > 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid norm > 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid norm > 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid norm > 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid norm > 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid norm > 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid norm > 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid norm > 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid norm > 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid norm > 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid norm > 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid norm > 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid norm > 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid norm > 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid norm > 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid norm > 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid norm > 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid norm > 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid norm > 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid norm > 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid norm > 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid norm > 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid norm > 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid norm > 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid norm > 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid norm > 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid norm > 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid norm > 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid norm > 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid norm > 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid norm > 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid norm > 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid norm > 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid norm > 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid norm > 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid norm > 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid norm > 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid norm > 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid norm > 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid norm > 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid norm > 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid norm > 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid norm > 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid norm > 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid norm > 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid norm > 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid norm > 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid norm > 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid norm > 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid norm > 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid norm > 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid norm > 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid norm > 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid norm > 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid norm > 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid norm > 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid norm > 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid norm > 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid norm > 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid norm > 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid norm > 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid norm > 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid norm > 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid norm > 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid norm > 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid norm > 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid norm > 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid norm > 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid norm > 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid norm > 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid norm > 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid norm > 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid norm > 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid norm > 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid norm > 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid norm > 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid norm > 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid norm > 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid norm > 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid norm > 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid norm > 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid norm > 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid norm > 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid norm > 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid norm > 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid norm > 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid norm > 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid norm > 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid norm > 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid norm > 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid norm > 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid norm > 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid norm > 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid norm > 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid norm > 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid norm > 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid norm > 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid norm > 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid norm > 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid norm > 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid norm > 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 > > > > > > > > > > > > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : > > > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u and c. > Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for > each field. Then try replacing the direct solvers LU with hypre BoomerAMG > first one at a time. > > > > > > Let us know how it goes and we'll make additional suggestions, > > > > > > Barry > > > > > > > > > > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > > > > > > > Hi Barry, > > > > > > > > (1) > > > > I am basically solving the equilibrium coupled with phase field > equation: > > > > > > > > 1-D example > > > > u is displacement and c is phase-field parameter. > > > > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 > > > > > > > > phase-field equation: 2*G_c*L*(\Delta c)-E*(\epsilon)^2*c+G_c/2L(1- > c)=0 > > > > > > > > I solve the above 2 equations coupled. > > > > it is the formulation for quasi-static fracture problem, where G_c > is the critical energy release rate and L is the length scale in > phase-field method (both constant). > > > > > > > > The free energy I am using now is > > > > 1-D: > > > > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > > > > > > > > > > it is not convex w.r.t u and c simultaneously. > > > > > > > > (2) > > > > > > > > with an appropriate step size. Newton's method usually converges > with 5 iteration, and I can see the quadratic convergence of Newton's > method. > > > > > > > > > > > > > > > > > > > > Thanks, > > > > Josh > > > > > > > > > > > > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > > > > > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > > > > > > > > > Hi, > > > > > > > > > > I am using GRMES to solve the linear systems within Newton > Raphson. > > > > > I am using finite element method to solve fracture problem with > phase field method.(the formulation gives symmetric but indefinite hessian > so can't use CG) > > > > > > > > What exact equations are you using for the phase field method? > > > > > > > > With the direct LU solver roughly how many iterations does your > Newton's method take? > > > > > > > > > > > > Barry > > > > > > > > > > > > > > The total iteration number to solve one linear system is often > very large( > 2000) even for a small sized problem(120K degree of freedom). > I've tried different preconditioner, but it doesn't help a lot. I have > checked my hessian and right hand side, and sure they are correct. > > > > > > > > > > I think it might stem from the great difference in element > size(max/min=100) and damage stiffness around crack. > > > > > > > > > > Anyone has idea to reduce the number of iteration? > > > > > > > > > > Now, I get away with it by using LU, which is not ideal for large > size problem (I will have to run it in the future) > > > > > > > > > > > > > > > Thanks, > > > > > Josh > > > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Fri Aug 10 03:58:27 2018 From: jroman at dsic.upv.es (Jose E. Roman) Date: Fri, 10 Aug 2018 10:58:27 +0200 Subject: [petsc-users] SLEPc4py function composition In-Reply-To: References: <96EA936E-F21D-448E-AD15-918B8BC81CD9@dsic.upv.es> Message-ID: <44D0909A-FAFC-486A-B0D5-09F92C04AFDB@dsic.upv.es> I have added the function to the master branch of slepc4py. To use it, you should do something like this: f.setType(SLEPc.FN.Type.COMBINE) f.setCombineChildren(SLEPc.FN.CombineType.COMPOSE,fa,fb) where fa is (c^2-lambda^2) and fb is the square root. It seems an interesting problem. I would like to know more about it. If you want, send a short description of the problem to my personal email or to slepc-maint. Jose > El 10 ago 2018, a las 10:15, Daniel Kiefer escribi?: > > That would be great! :) > > I would need this in order to solve an eigenvalue problem with a sqrt(c^2 - lambda^2) term. > > Looking forward to your message. > > Best regards > Daniel > > On 09.08.2018 21:36, Jose E. Roman wrote: >> I will add it in the next days and let you know. >> Jose >>> El 9 ago 2018, a las 21:07, Daniel Kiefer escribi?: >>> >>> Dear SLEPc users, >>> >>> I am trying to solve a non-linear eigenvalue problem for which I need to use FNCombineSetChildren(). It seems to me that this function is not implemented in the Python bindings? Any information or help would be much appreciated. >>> >>> Best regards >>> Daniel Kiefer >>> >>> -- >>> Daniel Kiefer, M.Sc. >>> Friedrich-Alexander-Universit?t Erlangen-N?rnberg (FAU) >>> Lehrstuhl f?r Sensorik >>> Paul-Gordan-Stra?e 3/5, 91052 Erlangen, Germany >>> Tel. +49 9131 85 23134, Fax +49 9131 85 23133 >>> >>> University of Erlangen-Nuremberg (FAU) >>> Chair of Sensor Technology >>> > From mfadams at lbl.gov Fri Aug 10 16:01:26 2018 From: mfadams at lbl.gov (Mark Adams) Date: Fri, 10 Aug 2018 17:01:26 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> Message-ID: On Thu, Aug 9, 2018 at 2:11 PM Smith, Barry F. wrote: > > Mark, > > We are only asking for the best GAMG options for linear elasticity? > THe defaults are a good place to start for linear elasticity. I assume these are 3D with low order elements, in which case you probably want to add '-pc_gamg_square_graph 10' (the default is 1). > > Barry > > > > On Aug 9, 2018, at 11:55 AM, Mark Adams wrote: > > > > Fracture mechanics problems are hard in my experience. You should try > hypre and ML as well (you need to configure to download these packages). > > > > On Thu, Aug 9, 2018 at 11:27 AM Smith, Barry F. > wrote: > > > > Ok, PCGAMG should work well for linear elasticity so on your reduced > problem use -pc_type gamg then the group (Mark) will have specific > suggestions for options. We want to see about 20 iterations for > "well-behaved" linear elasticity problems. > > > > Barry > > > > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: > > > > > > Hi Barry, > > > > > > Thanks for your help. > > > > > > I removed the phase field from my formulation by setting all > corresponding degrees of freedom as Dirichlet boundary condition, so > > > my formulation becomes simply linear elastic. > > > Then I use CG for KSP and algebraic multigrid for precondiitoner. For > a 150K dofs problem, the linear solver converges with 200s iteration(still > too much I think), but with GMRES it again takes 2000 iteration to > converge. with GMRES and default PC, it barely converges within 10K > iteration. > > > > > > I will double check my hessian. below is the ksp monitor output from > GMRES and gamg PC for first 500 iteration. > > > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid norm > 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid norm > 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid norm > 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid norm > 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid norm > 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid norm > 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid norm > 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid norm > 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid norm > 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid norm > 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid norm > 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid norm > 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid norm > 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid norm > 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid norm > 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid norm > 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid norm > 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid norm > 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid norm > 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid norm > 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid norm > 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid norm > 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid norm > 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid norm > 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid norm > 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid norm > 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid norm > 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid norm > 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid norm > 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid norm > 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid norm > 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid norm > 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid norm > 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid norm > 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid norm > 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid norm > 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid norm > 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid norm > 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid norm > 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid norm > 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid norm > 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid norm > 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid norm > 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid norm > 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid norm > 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid norm > 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid norm > 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid norm > 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid norm > 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid norm > 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid norm > 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid norm > 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid norm > 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid norm > 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid norm > 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid norm > 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid norm > 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid norm > 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid norm > 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid norm > 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid norm > 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid norm > 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid norm > 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid norm > 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid norm > 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid norm > 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid norm > 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid norm > 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid norm > 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid norm > 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid norm > 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid norm > 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid norm > 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid norm > 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid norm > 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid norm > 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid norm > 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid norm > 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid norm > 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid norm > 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid norm > 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid norm > 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid norm > 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid norm > 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid norm > 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid norm > 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid norm > 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid norm > 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid norm > 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid norm > 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid norm > 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid norm > 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid norm > 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid norm > 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid norm > 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid norm > 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid norm > 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid norm > 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid norm > 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid norm > 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid norm > 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid norm > 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid norm > 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid norm > 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid norm > 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid norm > 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid norm > 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid norm > 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid norm > 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid norm > 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid norm > 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid norm > 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid norm > 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid norm > 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid norm > 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid norm > 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid norm > 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid norm > 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid norm > 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid norm > 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid norm > 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid norm > 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid norm > 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid norm > 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid norm > 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid norm > 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid norm > 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid norm > 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid norm > 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid norm > 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid norm > 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid norm > 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid norm > 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid norm > 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid norm > 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid norm > 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid norm > 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid norm > 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid norm > 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid norm > 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid norm > 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid norm > 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid norm > 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid norm > 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid norm > 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid norm > 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid norm > 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid norm > 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid norm > 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid norm > 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid norm > 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid norm > 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid norm > 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid norm > 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid norm > 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid norm > 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid norm > 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid norm > 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid norm > 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid norm > 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid norm > 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid norm > 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid norm > 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid norm > 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid norm > 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid norm > 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid norm > 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid norm > 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid norm > 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid norm > 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid norm > 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid norm > 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid norm > 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid norm > 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid norm > 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid norm > 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid norm > 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid norm > 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid norm > 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid norm > 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid norm > 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid norm > 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid norm > 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid norm > 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid norm > 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid norm > 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid norm > 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid norm > 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid norm > 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid norm > 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid norm > 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid norm > 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid norm > 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid norm > 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid norm > 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid norm > 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid norm > 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid norm > 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid norm > 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid norm > 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid norm > 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid norm > 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid norm > 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid norm > 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid norm > 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid norm > 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid norm > 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid norm > 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid norm > 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid norm > 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid norm > 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid norm > 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid norm > 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid norm > 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid norm > 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid norm > 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid norm > 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid norm > 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid norm > 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid norm > 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid norm > 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid norm > 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid norm > 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid norm > 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid norm > 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid norm > 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid norm > 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid norm > 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid norm > 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid norm > 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid norm > 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid norm > 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid norm > 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid norm > 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid norm > 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid norm > 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid norm > 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid norm > 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid norm > 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid norm > 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid norm > 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid norm > 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid norm > 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid norm > 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid norm > 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid norm > 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid norm > 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid norm > 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid norm > 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid norm > 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid norm > 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid norm > 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid norm > 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid norm > 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid norm > 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid norm > 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid norm > 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid norm > 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid norm > 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid norm > 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid norm > 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid norm > 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid norm > 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid norm > 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid norm > 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid norm > 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid norm > 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid norm > 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid norm > 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid norm > 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid norm > 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid norm > 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid norm > 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid norm > 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid norm > 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid norm > 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid norm > 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid norm > 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid norm > 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid norm > 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid norm > 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid norm > 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid norm > 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid norm > 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid norm > 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid norm > 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid norm > 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid norm > 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid norm > 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid norm > 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid norm > 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid norm > 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid norm > 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid norm > 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid norm > 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid norm > 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid norm > 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid norm > 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid norm > 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid norm > 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid norm > 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid norm > 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid norm > 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid norm > 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid norm > 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid norm > 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid norm > 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid norm > 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid norm > 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid norm > 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid norm > 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid norm > 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid norm > 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid norm > 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid norm > 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid norm > 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid norm > 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid norm > 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid norm > 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid norm > 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid norm > 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid norm > 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid norm > 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid norm > 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid norm > 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid norm > 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid norm > 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid norm > 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid norm > 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid norm > 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid norm > 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid norm > 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid norm > 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid norm > 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid norm > 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid norm > 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid norm > 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid norm > 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid norm > 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid norm > 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid norm > 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid norm > 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid norm > 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid norm > 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid norm > 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid norm > 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid norm > 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid norm > 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid norm > 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid norm > 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid norm > 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid norm > 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid norm > 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid norm > 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid norm > 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid norm > 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid norm > 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid norm > 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid norm > 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid norm > 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid norm > 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid norm > 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid norm > 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid norm > 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid norm > 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid norm > 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid norm > 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid norm > 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid norm > 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid norm > 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid norm > 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid norm > 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid norm > 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid norm > 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid norm > 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid norm > 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid norm > 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid norm > 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid norm > 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid norm > 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid norm > 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid norm > 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid norm > 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid norm > 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid norm > 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid norm > 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid norm > 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid norm > 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid norm > 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid norm > 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid norm > 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid norm > 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid norm > 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid norm > 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid norm > 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid norm > 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid norm > 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid norm > 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid norm > 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid norm > 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid norm > 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid norm > 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid norm > 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid norm > 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid norm > 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid norm > 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid norm > 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid norm > 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid norm > 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid norm > 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid norm > 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid norm > 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid norm > 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid norm > 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid norm > 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid norm > 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid norm > 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid norm > 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid norm > 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid norm > 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid norm > 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid norm > 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid norm > 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid norm > 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid norm > 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid norm > 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid norm > 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid norm > 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid norm > 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid norm > 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid norm > 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid norm > 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid norm > 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid norm > 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid norm > 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid norm > 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid norm > 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid norm > 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid norm > 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid norm > 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid norm > 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid norm > 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid norm > 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid norm > 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid norm > 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid norm > 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid norm > 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid norm > 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid norm > 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid norm > 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid norm > 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid norm > 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid norm > 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid norm > 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid norm > 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid norm > 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid norm > 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid norm > 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid norm > 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid norm > 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid norm > 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid norm > 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid norm > 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid norm > 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid norm > 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid norm > 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid norm > 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid norm > 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid norm > 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid norm > 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid norm > 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid norm > 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid norm > 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid norm > 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid norm > 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid norm > 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid norm > 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid norm > 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid norm > 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid norm > 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid norm > 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid norm > 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid norm > 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid norm > 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid norm > 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid norm > 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid norm > 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid norm > 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid norm > 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid norm > 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid norm > 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid norm > 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid norm > 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid norm > 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid norm > 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid norm > 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid norm > 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid norm > 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid norm > 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid norm > 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid norm > 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 > > > > > > > > > > > > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : > > > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u and c. > Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for > each field. Then try replacing the direct solvers LU with hypre BoomerAMG > first one at a time. > > > > > > Let us know how it goes and we'll make additional suggestions, > > > > > > Barry > > > > > > > > > > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > > > > > > > Hi Barry, > > > > > > > > (1) > > > > I am basically solving the equilibrium coupled with phase field > equation: > > > > > > > > 1-D example > > > > u is displacement and c is phase-field parameter. > > > > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 > > > > > > > > phase-field equation: 2*G_c*L*(\Delta > c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 > > > > > > > > I solve the above 2 equations coupled. > > > > it is the formulation for quasi-static fracture problem, where G_c > is the critical energy release rate and L is the length scale in > phase-field method (both constant). > > > > > > > > The free energy I am using now is > > > > 1-D: > > > > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > > > > > > > > > > it is not convex w.r.t u and c simultaneously. > > > > > > > > (2) > > > > > > > > with an appropriate step size. Newton's method usually converges > with 5 iteration, and I can see the quadratic convergence of Newton's > method. > > > > > > > > > > > > > > > > > > > > Thanks, > > > > Josh > > > > > > > > > > > > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > > > > > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > > > > > > > > > Hi, > > > > > > > > > > I am using GRMES to solve the linear systems within Newton > Raphson. > > > > > I am using finite element method to solve fracture problem with > phase field method.(the formulation gives symmetric but indefinite hessian > so can't use CG) > > > > > > > > What exact equations are you using for the phase field method? > > > > > > > > With the direct LU solver roughly how many iterations does your > Newton's method take? > > > > > > > > > > > > Barry > > > > > > > > > > > > > > The total iteration number to solve one linear system is often > very large( > 2000) even for a small sized problem(120K degree of freedom). > I've tried different preconditioner, but it doesn't help a lot. I have > checked my hessian and right hand side, and sure they are correct. > > > > > > > > > > I think it might stem from the great difference in element > size(max/min=100) and damage stiffness around crack. > > > > > > > > > > Anyone has idea to reduce the number of iteration? > > > > > > > > > > Now, I get away with it by using LU, which is not ideal for large > size problem (I will have to run it in the future) > > > > > > > > > > > > > > > Thanks, > > > > > Josh > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sat Aug 11 14:27:05 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Sat, 11 Aug 2018 19:27:05 +0000 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> Message-ID: <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> > On Aug 9, 2018, at 9:11 PM, Josh L wrote: > > > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : > > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: > > > > Hi Barry, > > > > I use the example ex49 of KSP(linear elasticity problem), and it's output of ksp monitor is the same as my reduced problem, so I think my code is correct , at least for the reduced problem. > > Are you using -pc_type gamg ? > > No, just with GMRES and default PC. > strangely, with gamg, the final solution is still the same but ksp output becomes different between my code and petsc example. > with -pc_type gamg, my code take 35 iteration and petsc example takes only 7. You should use GAMG for elasticity type problems. Does you code set the near null space like the example does? > > Thanks. > > > > > > Within a Newton's method, several linear system(Ax=b) is solved, and b is the residual vector whose norm becomes smaller and smaller. > > Should I change rtol for KSP ? since ||b|| is reducing, and converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is rarely satisfied ) > > I observe that for the first linear solve in Newton's method, iterative solver converges with okay number of iteration > > , but for the following linear solve, iterative solver takes more and more iterations. > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 > > Try also -ksp_pc_side right > > > Barry > > > > > > > > Thanks, > > Josh > > > > > > > > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : > > > > Ok, PCGAMG should work well for linear elasticity so on your reduced problem use -pc_type gamg then the group (Mark) will have specific suggestions for options. We want to see about 20 iterations for "well-behaved" linear elasticity problems. > > > > Barry > > > > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: > > > > > > Hi Barry, > > > > > > Thanks for your help. > > > > > > I removed the phase field from my formulation by setting all corresponding degrees of freedom as Dirichlet boundary condition, so > > > my formulation becomes simply linear elastic. > > > Then I use CG for KSP and algebraic multigrid for precondiitoner. For a 150K dofs problem, the linear solver converges with 200s iteration(still too much I think), but with GMRES it again takes 2000 iteration to converge. with GMRES and default PC, it barely converges within 10K iteration. > > > > > > I will double check my hessian. below is the ksp monitor output from GMRES and gamg PC for first 500 iteration. > > > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 > > > > > > > > > > > > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : > > > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for each field. Then try replacing the direct solvers LU with hypre BoomerAMG first one at a time. > > > > > > Let us know how it goes and we'll make additional suggestions, > > > > > > Barry > > > > > > > > > > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > > > > > > > Hi Barry, > > > > > > > > (1) > > > > I am basically solving the equilibrium coupled with phase field equation: > > > > > > > > 1-D example > > > > u is displacement and c is phase-field parameter. > > > > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 > > > > > > > > phase-field equation: 2*G_c*L*(\Delta c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 > > > > > > > > I solve the above 2 equations coupled. > > > > it is the formulation for quasi-static fracture problem, where G_c is the critical energy release rate and L is the length scale in phase-field method (both constant). > > > > > > > > The free energy I am using now is > > > > 1-D: > > > > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > > > > > > > > > > it is not convex w.r.t u and c simultaneously. > > > > > > > > (2) > > > > > > > > with an appropriate step size. Newton's method usually converges with 5 iteration, and I can see the quadratic convergence of Newton's method. > > > > > > > > > > > > > > > > > > > > Thanks, > > > > Josh > > > > > > > > > > > > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > > > > > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > > > > > > > > > Hi, > > > > > > > > > > I am using GRMES to solve the linear systems within Newton Raphson. > > > > > I am using finite element method to solve fracture problem with phase field method.(the formulation gives symmetric but indefinite hessian so can't use CG) > > > > > > > > What exact equations are you using for the phase field method? > > > > > > > > With the direct LU solver roughly how many iterations does your Newton's method take? > > > > > > > > > > > > Barry > > > > > > > > > > > > > > The total iteration number to solve one linear system is often very large( > 2000) even for a small sized problem(120K degree of freedom). I've tried different preconditioner, but it doesn't help a lot. I have checked my hessian and right hand side, and sure they are correct. > > > > > > > > > > I think it might stem from the great difference in element size(max/min=100) and damage stiffness around crack. > > > > > > > > > > Anyone has idea to reduce the number of iteration? > > > > > > > > > > Now, I get away with it by using LU, which is not ideal for large size problem (I will have to run it in the future) > > > > > > > > > > > > > > > Thanks, > > > > > Josh > > > > > > > > > > > > > > > > > > > > > > > From t.appel17 at imperial.ac.uk Sun Aug 12 11:42:58 2018 From: t.appel17 at imperial.ac.uk (Appel, Thibaut) Date: Sun, 12 Aug 2018 16:42:58 +0000 Subject: [petsc-users] PETSc doesn't allow use of multithreaded MKL with MUMPS + fblaslapack? Message-ID: <6FDA6170-D2F9-4AA6-92B8-1BDEA845FFBB@ic.ac.uk> Good afternoon, I have an application code written in pure MPI but wanted to exploit multithreading in MUMPS (contained in calls to BLAS routines) On a high-end parallel cluster I?m using, I?m linking with the Intel MKL library but it seems that PETSc won?t configure the way I want: ./configure [?] ?with-openmp=1 --with-pic=1 --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blaslapack-dir=${MKLROOT} --with-scalapack-lib="-L${MKLROOT}/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" --with-scalapack-include=${MKLROOT}/include --download-metis --download-parmetis --download-mumps yields BLAS/LAPACK: -lmkl_intel_lp64 -lmkl_sequential -lmkl_core -lpthread while if I configure with cpardiso on top of the same flags ./configure [?] ?with-openmp=1 ?with-pic=1 --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blaslapack-dir=${MKLROOT} --with-scalapack-lib="-L${MKLROOT}/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" --with-scalapack-include=${MKLROOT}/include --with-mkl_cpardiso-dir=${MKLROOT} --download-metis --download-parmetis --download-mumps the configure script says =============================================== BLASLAPACK: Looking for Multithreaded MKL for C/Pardiso =============================================== and yields BLAS/LAPACK: -lmkl_intel_lp64 -lmkl_core -lmkl_intel_thread -lmkl_blacs_intelmpi_lp64 -liomp5 -ldl -lpthread In other words, there is no current possibility of activating multithreaded BLAS with MUMPS in spite of the option ?with-openmp=1, as libmkl_sequential is linked. Is it not possible to fix that and use libmkl_intel_thread by default? On another smaller cluster, I do not have MKL and configure PETSc with BLAS downloaded with ?download-fblaslapack, which is not multithreaded. Could you confirm I would need to link with a multithreaded BLAS library I downloaded myself and use ?with-openmp=1? Would it be `recognized` by the MUMPS installed by PETSc? Thanks for your support, Thibaut -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Sun Aug 12 14:20:42 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Sun, 12 Aug 2018 14:20:42 -0500 Subject: [petsc-users] PETSc doesn't allow use of multithreaded MKL with MUMPS + fblaslapack? In-Reply-To: <6FDA6170-D2F9-4AA6-92B8-1BDEA845FFBB@ic.ac.uk> References: <6FDA6170-D2F9-4AA6-92B8-1BDEA845FFBB@ic.ac.uk> Message-ID: Hm - its just a default - so you can always change the default value to a more suitable one for your usage. [i.e use --with-blaslapack-lib option instead of --with-blaslapack-dir option] For regular petsc build - we think that sequential MKL is the best match. For a build with C/Pardiso - I believe its best to use threaded MKL. Wrt with-openmp=1 - if threaded MKL is preferable - I guess we could change the default. But a default does not prevent one from using a preferred blas [whatever that is] Wrt fblaslapack - yes its not multi-threaded. But I believe openblas is multi-threaded [so you could use --download-openblas as alternative] The usual issue is - one cannot use threaded MKL [or any threaded library] as a black box. They would have to always be aware of how many mpi procs, and openmp threads are being used - and tweak these parameters constantly. The default for OpenMPI is to use the whole machine - i.e it expects 1 mpi task per node. If one users more mpi tasks per node - and does not reduce threads per node - they get bad performance. Hence we avoid using threaded MKL as a default.. Satish On Sun, 12 Aug 2018, Appel, Thibaut wrote: > Good afternoon, > > I have an application code written in pure MPI but wanted to exploit multithreading in MUMPS (contained in calls to BLAS routines) > On a high-end parallel cluster I?m using, I?m linking with the Intel MKL library but it seems that PETSc won?t configure the way I want: > > ./configure [?] ?with-openmp=1 --with-pic=1 --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blaslapack-dir=${MKLROOT} --with-scalapack-lib="-L${MKLROOT}/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" --with-scalapack-include=${MKLROOT}/include --download-metis --download-parmetis --download-mumps > > yields BLAS/LAPACK: -lmkl_intel_lp64 -lmkl_sequential -lmkl_core -lpthread > > while if I configure with cpardiso on top of the same flags > > ./configure [?] ?with-openmp=1 ?with-pic=1 --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blaslapack-dir=${MKLROOT} --with-scalapack-lib="-L${MKLROOT}/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" --with-scalapack-include=${MKLROOT}/include --with-mkl_cpardiso-dir=${MKLROOT} --download-metis --download-parmetis --download-mumps > > the configure script says > =============================================== > BLASLAPACK: Looking for Multithreaded MKL for C/Pardiso > =============================================== > > and yields BLAS/LAPACK: -lmkl_intel_lp64 -lmkl_core -lmkl_intel_thread -lmkl_blacs_intelmpi_lp64 -liomp5 -ldl -lpthread > > In other words, there is no current possibility of activating multithreaded BLAS with MUMPS in spite of the option ?with-openmp=1, as libmkl_sequential is linked. Is it not possible to fix that and use libmkl_intel_thread by default? > > On another smaller cluster, I do not have MKL and configure PETSc with BLAS downloaded with ?download-fblaslapack, which is not multithreaded. > Could you confirm I would need to link with a multithreaded BLAS library I downloaded myself and use ?with-openmp=1? Would it be `recognized` by the MUMPS installed by PETSc? > > Thanks for your support, > > > Thibaut > From t.appel17 at imperial.ac.uk Sun Aug 12 15:06:50 2018 From: t.appel17 at imperial.ac.uk (Appel, Thibaut) Date: Sun, 12 Aug 2018 20:06:50 +0000 Subject: [petsc-users] PETSc doesn't allow use of multithreaded MKL with MUMPS + fblaslapack? In-Reply-To: References: <6FDA6170-D2F9-4AA6-92B8-1BDEA845FFBB@ic.ac.uk> Message-ID: <765FE5AA-33C6-4B86-B0A2-00745ABBC2D4@ic.ac.uk> Hi Satish, > Le 12 ao?t 2018 ? 20:20, Satish Balay a ?crit : > > Hm - its just a default - so you can always change the default value > to a more suitable one for your usage. [i.e use --with-blaslapack-lib > option instead of --with-blaslapack-dir option] > Ok thanks I?m going to try that. > For regular petsc build - we think that sequential MKL is the best match. > > For a build with C/Pardiso - I believe its best to use threaded MKL. That makes sense. I think the threaded MKL defaults to the sequential MKL with 1 thread anyway > > Wrt with-openmp=1 - if threaded MKL is preferable - I guess we could > change the default. But a default does not prevent one from using a > preferred blas [whatever that is] > > Wrt fblaslapack - yes its not multi-threaded. But I believe openblas is > multi-threaded [so you could use --download-openblas as alternative] > > The usual issue is - one cannot use threaded MKL [or any threaded > library] as a black box. They would have to always be aware of how > many mpi procs, and openmp threads are being used - and tweak these > parameters constantly. The default for OpenMPI is to use the whole > machine - i.e it expects 1 mpi task per node. If one users more mpi > tasks per node - and does not reduce threads per node - they get bad > performance. Hence we avoid using threaded MKL as a default.. > I?m not sure to fully understand, w hy not? If I?m on a batch system, I specify a number of MPI tasks and a number of threads / MPI task that remain constant during the computation? If I?m not on a batch system, I just run mpirun with # of task and set OMP_NUM_THREADS that is the number of threads per MPI task and that?s it? (I use the Intel MPI library on one cluster and MPICH on the other) Thibaut > Satish > > On Sun, 12 Aug 2018, Appel, Thibaut wrote: > >> Good afternoon, >> >> I have an application code written in pure MPI but wanted to exploit multithreading in MUMPS (contained in calls to BLAS routines) >> On a high-end parallel cluster I?m using, I?m linking with the Intel MKL library but it seems that PETSc won?t configure the way I want: >> >> ./configure [?] ?with-openmp=1 --with-pic=1 --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blaslapack-dir=${MKLROOT} --with-scalapack-lib="-L${MKLROOT}/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" --with-scalapack-include=${MKLROOT}/include --download-metis --download-parmetis --download-mumps >> >> yields BLAS/LAPACK: -lmkl_intel_lp64 -lmkl_sequential -lmkl_core -lpthread >> >> while if I configure with cpardiso on top of the same flags >> >> ./configure [?] ?with-openmp=1 ?with-pic=1 --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blaslapack-dir=${MKLROOT} --with-scalapack-lib="-L${MKLROOT}/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" --with-scalapack-include=${MKLROOT}/include --with-mkl_cpardiso-dir=${MKLROOT} --download-metis --download-parmetis --download-mumps >> >> the configure script says >> =============================================== >> BLASLAPACK: Looking for Multithreaded MKL for C/Pardiso >> =============================================== >> >> and yields BLAS/LAPACK: -lmkl_intel_lp64 -lmkl_core -lmkl_intel_thread -lmkl_blacs_intelmpi_lp64 -liomp5 -ldl -lpthread >> >> In other words, there is no current possibility of activating multithreaded BLAS with MUMPS in spite of the option ?with-openmp=1, as libmkl_sequential is linked. Is it not possible to fix that and use libmkl_intel_thread by default? >> >> On another smaller cluster, I do not have MKL and configure PETSc with BLAS downloaded with ?download-fblaslapack, which is not multithreaded. >> Could you confirm I would need to link with a multithreaded BLAS library I downloaded myself and use ?with-openmp=1? Would it be `recognized` by the MUMPS installed by PETSc? >> >> Thanks for your support, >> >> >> Thibaut >> From balay at mcs.anl.gov Sun Aug 12 15:18:43 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Sun, 12 Aug 2018 15:18:43 -0500 Subject: [petsc-users] PETSc doesn't allow use of multithreaded MKL with MUMPS + fblaslapack? In-Reply-To: <765FE5AA-33C6-4B86-B0A2-00745ABBC2D4@ic.ac.uk> References: <6FDA6170-D2F9-4AA6-92B8-1BDEA845FFBB@ic.ac.uk> <765FE5AA-33C6-4B86-B0A2-00745ABBC2D4@ic.ac.uk> Message-ID: On Sun, 12 Aug 2018, Appel, Thibaut wrote: > Hi Satish, > > > Le 12 ao?t 2018 ? 20:20, Satish Balay a ?crit : > > > > Hm - its just a default - so you can always change the default value > > to a more suitable one for your usage. [i.e use --with-blaslapack-lib > > option instead of --with-blaslapack-dir option] > > > > Ok thanks I?m going to try that. > > > For regular petsc build - we think that sequential MKL is the best match. > > > > For a build with C/Pardiso - I believe its best to use threaded MKL. > > That makes sense. I think the threaded MKL defaults to the sequential MKL with 1 thread anyway > > > > > Wrt with-openmp=1 - if threaded MKL is preferable - I guess we could > > change the default. But a default does not prevent one from using a > > preferred blas [whatever that is] > > > > Wrt fblaslapack - yes its not multi-threaded. But I believe openblas is > > multi-threaded [so you could use --download-openblas as alternative] > > > > > The usual issue is - one cannot use threaded MKL [or any threaded > > library] as a black box. They would have to always be aware of how > > many mpi procs, and openmp threads are being used - and tweak these > > parameters constantly. The default for OpenMPI is to use the whole > > machine - i.e it expects 1 mpi task per node. If one users more mpi > > tasks per node - and does not reduce threads per node - they get bad > > performance. Hence we avoid using threaded MKL as a default.. > > > > I?m not sure to fully understand, w hy not? > If I?m on a batch system, I specify a number of MPI tasks and a number of threads / MPI task that remain constant during the computation? > If I?m not on a batch system, I just run mpirun with # of task and set OMP_NUM_THREADS that is the number of threads per MPI task and that?s it? > (I use the Intel MPI library on one cluster and MPICH on the other) you are aware of MKL being threaded - and setting OMP_NUM_THREADS etc appropriately. So you are not using it as a black box. Satish > > > Thibaut > > > Satish > > > > On Sun, 12 Aug 2018, Appel, Thibaut wrote: > > > >> Good afternoon, > >> > >> I have an application code written in pure MPI but wanted to exploit multithreading in MUMPS (contained in calls to BLAS routines) > >> On a high-end parallel cluster I?m using, I?m linking with the Intel MKL library but it seems that PETSc won?t configure the way I want: > >> > >> ./configure [?] ?with-openmp=1 --with-pic=1 --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blaslapack-dir=${MKLROOT} --with-scalapack-lib="-L${MKLROOT}/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" --with-scalapack-include=${MKLROOT}/include --download-metis --download-parmetis --download-mumps > >> > >> yields BLAS/LAPACK: -lmkl_intel_lp64 -lmkl_sequential -lmkl_core -lpthread > >> > >> while if I configure with cpardiso on top of the same flags > >> > >> ./configure [?] ?with-openmp=1 ?with-pic=1 --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blaslapack-dir=${MKLROOT} --with-scalapack-lib="-L${MKLROOT}/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" --with-scalapack-include=${MKLROOT}/include --with-mkl_cpardiso-dir=${MKLROOT} --download-metis --download-parmetis --download-mumps > >> > >> the configure script says > >> =============================================== > >> BLASLAPACK: Looking for Multithreaded MKL for C/Pardiso > >> =============================================== > >> > >> and yields BLAS/LAPACK: -lmkl_intel_lp64 -lmkl_core -lmkl_intel_thread -lmkl_blacs_intelmpi_lp64 -liomp5 -ldl -lpthread > >> > >> In other words, there is no current possibility of activating multithreaded BLAS with MUMPS in spite of the option ?with-openmp=1, as libmkl_sequential is linked. Is it not possible to fix that and use libmkl_intel_thread by default? > >> > >> On another smaller cluster, I do not have MKL and configure PETSc with BLAS downloaded with ?download-fblaslapack, which is not multithreaded. > >> Could you confirm I would need to link with a multithreaded BLAS library I downloaded myself and use ?with-openmp=1? Would it be `recognized` by the MUMPS installed by PETSc? > >> > >> Thanks for your support, > >> > >> > >> Thibaut > >> > > From balay at mcs.anl.gov Sun Aug 12 15:27:45 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Sun, 12 Aug 2018 15:27:45 -0500 Subject: [petsc-users] PETSc doesn't allow use of multithreaded MKL with MUMPS + fblaslapack? In-Reply-To: <765FE5AA-33C6-4B86-B0A2-00745ABBC2D4@ic.ac.uk> References: <6FDA6170-D2F9-4AA6-92B8-1BDEA845FFBB@ic.ac.uk> <765FE5AA-33C6-4B86-B0A2-00745ABBC2D4@ic.ac.uk> Message-ID: On Sun, 12 Aug 2018, Appel, Thibaut wrote: > Hi Satish, > > > Le 12 ao?t 2018 ? 20:20, Satish Balay a ?crit : > > > > Hm - its just a default - so you can always change the default value > > to a more suitable one for your usage. [i.e use --with-blaslapack-lib > > option instead of --with-blaslapack-dir option] > > > > Ok thanks I?m going to try that. > > > For regular petsc build - we think that sequential MKL is the best match. > > > > For a build with C/Pardiso - I believe its best to use threaded MKL. > > That makes sense. I think the threaded MKL defaults to the sequential MKL with 1 thread anyway I don't think this is true. google brings up the following: https://software.intel.com/en-us/articles/intel-math-kernel-library-intel-mkl-intel-mkl-100-threading "when the environment variable OMP_NUM_THREADS is undefined, Intel MKL may create multiple threads depending on problem size and the value of the MKL_DYNAMIC or other threading environment variables." OpenBlas does something similar. We have to explicitly set 'OPENBLAS_NUM_THREADS=1' variable to force it run single-threaded. Satish > > > > > Wrt with-openmp=1 - if threaded MKL is preferable - I guess we could > > change the default. But a default does not prevent one from using a > > preferred blas [whatever that is] > > > > Wrt fblaslapack - yes its not multi-threaded. But I believe openblas is > > multi-threaded [so you could use --download-openblas as alternative] > > > > > The usual issue is - one cannot use threaded MKL [or any threaded > > library] as a black box. They would have to always be aware of how > > many mpi procs, and openmp threads are being used - and tweak these > > parameters constantly. The default for OpenMPI is to use the whole > > machine - i.e it expects 1 mpi task per node. If one users more mpi > > tasks per node - and does not reduce threads per node - they get bad > > performance. Hence we avoid using threaded MKL as a default.. > > > > I?m not sure to fully understand, w hy not? > If I?m on a batch system, I specify a number of MPI tasks and a number of threads / MPI task that remain constant during the computation? > If I?m not on a batch system, I just run mpirun with # of task and set OMP_NUM_THREADS that is the number of threads per MPI task and that?s it? > (I use the Intel MPI library on one cluster and MPICH on the other) > > > Thibaut > > > Satish > > > > On Sun, 12 Aug 2018, Appel, Thibaut wrote: > > > >> Good afternoon, > >> > >> I have an application code written in pure MPI but wanted to exploit multithreading in MUMPS (contained in calls to BLAS routines) > >> On a high-end parallel cluster I?m using, I?m linking with the Intel MKL library but it seems that PETSc won?t configure the way I want: > >> > >> ./configure [?] ?with-openmp=1 --with-pic=1 --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blaslapack-dir=${MKLROOT} --with-scalapack-lib="-L${MKLROOT}/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" --with-scalapack-include=${MKLROOT}/include --download-metis --download-parmetis --download-mumps > >> > >> yields BLAS/LAPACK: -lmkl_intel_lp64 -lmkl_sequential -lmkl_core -lpthread > >> > >> while if I configure with cpardiso on top of the same flags > >> > >> ./configure [?] ?with-openmp=1 ?with-pic=1 --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blaslapack-dir=${MKLROOT} --with-scalapack-lib="-L${MKLROOT}/lib/intel64 -lmkl_scalapack_lp64 -lmkl_blacs_intelmpi_lp64" --with-scalapack-include=${MKLROOT}/include --with-mkl_cpardiso-dir=${MKLROOT} --download-metis --download-parmetis --download-mumps > >> > >> the configure script says > >> =============================================== > >> BLASLAPACK: Looking for Multithreaded MKL for C/Pardiso > >> =============================================== > >> > >> and yields BLAS/LAPACK: -lmkl_intel_lp64 -lmkl_core -lmkl_intel_thread -lmkl_blacs_intelmpi_lp64 -liomp5 -ldl -lpthread > >> > >> In other words, there is no current possibility of activating multithreaded BLAS with MUMPS in spite of the option ?with-openmp=1, as libmkl_sequential is linked. Is it not possible to fix that and use libmkl_intel_thread by default? > >> > >> On another smaller cluster, I do not have MKL and configure PETSc with BLAS downloaded with ?download-fblaslapack, which is not multithreaded. > >> Could you confirm I would need to link with a multithreaded BLAS library I downloaded myself and use ?with-openmp=1? Would it be `recognized` by the MUMPS installed by PETSc? > >> > >> Thanks for your support, > >> > >> > >> Thibaut > >> > > From bsmith at mcs.anl.gov Sun Aug 12 22:02:14 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Mon, 13 Aug 2018 03:02:14 +0000 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> Message-ID: <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Sending this to PETSc users because someone else (Mark?) will know why the Eigen estimator fails at iteration 0. I notice you are using a real old version of PETSc, for GAMG which is a fast moving component of PETSc this may fail. You really should work with the latest version of PETSc. Why aren't you? Barry > On Aug 12, 2018, at 9:25 PM, Josh L wrote: > > Hi Barry, > > I set the near null space following the example, but I get error when solving it with -pc_type gamg(no error if solving with default PC). > Moreover, there will be no error if I don't call VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space will not affect iteration number. > > Is it because the way I set Dirichlet boundary conditions? > I just zero out the corresponding row and modify right hand size. > There is no Neumann bc. > > > Thanks, > > The following is the error I get > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Petsc has generated inconsistent data > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at iteration 0 > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell named nid00009 by yslo Sun Aug 12 21:14:17 2018 > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 --with-scalar-type=real --with-shared-libraries=1 --with-precision=double --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack --with-spai=1 --download-spai --with-sundials=1 --download-sundials --with-hdf5=1 --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 --download-superlu_dist --with-superlu=1 --download-superlu --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/16.0.1.150/compilers_and_libraries_2016.1.150/linux/mkl --CFLAGS="-xhost -O2 -g" --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/cheby/cheby.c > [0]PETSC ERROR: #2 KSPSolve() line 656 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > [0]PETSC ERROR: #7 PCApply_MG() line 343 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > [0]PETSC ERROR: #8 PCApply() line 482 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/private/kspimpl.h > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itres.c > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/gmres/gmres.c > [0]PETSC ERROR: #12 KSPSolve() line 656 in /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c > > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : > > > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: > > > > > > > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : > > > > > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: > > > > > > Hi Barry, > > > > > > I use the example ex49 of KSP(linear elasticity problem), and it's output of ksp monitor is the same as my reduced problem, so I think my code is correct , at least for the reduced problem. > > > > Are you using -pc_type gamg ? > > > > No, just with GMRES and default PC. > > strangely, with gamg, the final solution is still the same but ksp output becomes different between my code and petsc example. > > with -pc_type gamg, my code take 35 iteration and petsc example takes only 7. > > You should use GAMG for elasticity type problems. Does you code set the near null space like the example does? > > > > > Thanks. > > > > > > > > > > Within a Newton's method, several linear system(Ax=b) is solved, and b is the residual vector whose norm becomes smaller and smaller. > > > Should I change rtol for KSP ? since ||b|| is reducing, and converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is rarely satisfied ) > > > I observe that for the first linear solve in Newton's method, iterative solver converges with okay number of iteration > > > , but for the following linear solve, iterative solver takes more and more iterations. > > > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 > > > > Try also -ksp_pc_side right > > > > > > Barry > > > > > > > > > > > > > Thanks, > > > Josh > > > > > > > > > > > > > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : > > > > > > Ok, PCGAMG should work well for linear elasticity so on your reduced problem use -pc_type gamg then the group (Mark) will have specific suggestions for options. We want to see about 20 iterations for "well-behaved" linear elasticity problems. > > > > > > Barry > > > > > > > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: > > > > > > > > Hi Barry, > > > > > > > > Thanks for your help. > > > > > > > > I removed the phase field from my formulation by setting all corresponding degrees of freedom as Dirichlet boundary condition, so > > > > my formulation becomes simply linear elastic. > > > > Then I use CG for KSP and algebraic multigrid for precondiitoner. For a 150K dofs problem, the linear solver converges with 200s iteration(still too much I think), but with GMRES it again takes 2000 iteration to converge. with GMRES and default PC, it barely converges within 10K iteration. > > > > > > > > I will double check my hessian. below is the ksp monitor output from GMRES and gamg PC for first 500 iteration. > > > > > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 > > > > > > > > > > > > > > > > > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : > > > > > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for each field. Then try replacing the direct solvers LU with hypre BoomerAMG first one at a time. > > > > > > > > Let us know how it goes and we'll make additional suggestions, > > > > > > > > Barry > > > > > > > > > > > > > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > > > > > > > > > Hi Barry, > > > > > > > > > > (1) > > > > > I am basically solving the equilibrium coupled with phase field equation: > > > > > > > > > > 1-D example > > > > > u is displacement and c is phase-field parameter. > > > > > > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 > > > > > > > > > > phase-field equation: 2*G_c*L*(\Delta c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 > > > > > > > > > > I solve the above 2 equations coupled. > > > > > it is the formulation for quasi-static fracture problem, where G_c is the critical energy release rate and L is the length scale in phase-field method (both constant). > > > > > > > > > > The free energy I am using now is > > > > > 1-D: > > > > > > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > > > > > > > > > > > > > it is not convex w.r.t u and c simultaneously. > > > > > > > > > > (2) > > > > > > > > > > with an appropriate step size. Newton's method usually converges with 5 iteration, and I can see the quadratic convergence of Newton's method. > > > > > > > > > > > > > > > > > > > > > > > > > Thanks, > > > > > Josh > > > > > > > > > > > > > > > > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > > > > > > > > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L wrote: > > > > > > > > > > > > Hi, > > > > > > > > > > > > I am using GRMES to solve the linear systems within Newton Raphson. > > > > > > I am using finite element method to solve fracture problem with phase field method.(the formulation gives symmetric but indefinite hessian so can't use CG) > > > > > > > > > > What exact equations are you using for the phase field method? > > > > > > > > > > With the direct LU solver roughly how many iterations does your Newton's method take? > > > > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > The total iteration number to solve one linear system is often very large( > 2000) even for a small sized problem(120K degree of freedom). I've tried different preconditioner, but it doesn't help a lot. I have checked my hessian and right hand side, and sure they are correct. > > > > > > > > > > > > I think it might stem from the great difference in element size(max/min=100) and damage stiffness around crack. > > > > > > > > > > > > Anyone has idea to reduce the number of iteration? > > > > > > > > > > > > Now, I get away with it by using LU, which is not ideal for large size problem (I will have to run it in the future) > > > > > > > > > > > > > > > > > > Thanks, > > > > > > Josh > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > From knepley at gmail.com Mon Aug 13 09:13:42 2018 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 13 Aug 2018 10:13:42 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: On Sun, Aug 12, 2018 at 11:02 PM Smith, Barry F. wrote: > > Sending this to PETSc users because someone else (Mark?) will know why > the Eigen estimator fails at iteration 0. > Are you sure its the estimator? That should be GMRES, but the error is coming from Chebyshev. You are remembering to put something on the diagonal of the zeroed rows, right? Matt > I notice you are using a real old version of PETSc, for GAMG which is a > fast moving component of PETSc this may fail. You really should work with > the latest version of PETSc. Why aren't you? > > Barry > > > > On Aug 12, 2018, at 9:25 PM, Josh L wrote: > > > > Hi Barry, > > > > I set the near null space following the example, but I get error when > solving it with -pc_type gamg(no error if solving with default PC). > > Moreover, there will be no error if I don't call > VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space > will not affect iteration number. > > > > Is it because the way I set Dirichlet boundary conditions? > > I just zero out the corresponding row and modify right hand size. > > There is no Neumann bc. > > > > > > Thanks, > > > > The following is the error I get > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [0]PETSC ERROR: Petsc has generated inconsistent data > > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at iteration 0 > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 > > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell named > nid00009 by yslo Sun Aug 12 21:14:17 2018 > > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 > --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages > --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 > --with-scalar-type=real --with-shared-libraries=1 --with-precision=double > --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 > --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack > --with-spai=1 --download-spai --with-sundials=1 --download-sundials > --with-hdf5=1 > --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 > --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis > --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack > --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles > --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 > --download-superlu_dist --with-superlu=1 --download-superlu > --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis > --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/ > 16.0.1.150/compilers_and_libraries_2016.1.150/linux/mkl --CFLAGS="-xhost > -O2 -g" --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" > > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/cheby/cheby.c > > [0]PETSC ERROR: #2 KSPSolve() line 656 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c > > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > > [0]PETSC ERROR: #7 PCApply_MG() line 343 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > > [0]PETSC ERROR: #8 PCApply() line 482 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/interface/precon.c > > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/private/kspimpl.h > > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itres.c > > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/gmres/gmres.c > > [0]PETSC ERROR: #12 KSPSolve() line 656 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c > > > > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : > > > > > > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: > > > > > > > > > > > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : > > > > > > > > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: > > > > > > > > Hi Barry, > > > > > > > > I use the example ex49 of KSP(linear elasticity problem), and it's > output of ksp monitor is the same as my reduced problem, so I think my code > is correct , at least for the reduced problem. > > > > > > Are you using -pc_type gamg ? > > > > > > No, just with GMRES and default PC. > > > strangely, with gamg, the final solution is still the same but > ksp output becomes different between my code and petsc example. > > > with -pc_type gamg, my code take 35 iteration and petsc example > takes only 7. > > > > You should use GAMG for elasticity type problems. Does you code set > the near null space like the example does? > > > > > > > > Thanks. > > > > > > > > > > > > > > Within a Newton's method, several linear system(Ax=b) is solved, and > b is the residual vector whose norm becomes smaller and smaller. > > > > Should I change rtol for KSP ? since ||b|| is reducing, and converge > requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is rarely > satisfied ) > > > > I observe that for the first linear solve in Newton's method, > iterative solver converges with okay number of iteration > > > > , but for the following linear solve, iterative solver takes more > and more iterations. > > > > > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 > > > > > > Try also -ksp_pc_side right > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > Thanks, > > > > Josh > > > > > > > > > > > > > > > > > > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : > > > > > > > > Ok, PCGAMG should work well for linear elasticity so on your > reduced problem use -pc_type gamg then the group (Mark) will have specific > suggestions for options. We want to see about 20 iterations for > "well-behaved" linear elasticity problems. > > > > > > > > Barry > > > > > > > > > > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: > > > > > > > > > > Hi Barry, > > > > > > > > > > Thanks for your help. > > > > > > > > > > I removed the phase field from my formulation by setting all > corresponding degrees of freedom as Dirichlet boundary condition, so > > > > > my formulation becomes simply linear elastic. > > > > > Then I use CG for KSP and algebraic multigrid for precondiitoner. > For a 150K dofs problem, the linear solver converges with 200s > iteration(still too much I think), but with GMRES it again takes 2000 > iteration to converge. with GMRES and default PC, it barely converges > within 10K iteration. > > > > > > > > > > I will double check my hessian. below is the ksp monitor output > from GMRES and gamg PC for first 500 iteration. > > > > > > > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid > norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 > > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid > norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 > > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid > norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 > > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid > norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 > > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid > norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 > > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid > norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 > > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid > norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 > > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid > norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 > > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid > norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 > > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid > norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 > > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid > norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 > > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid > norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 > > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid > norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 > > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid > norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 > > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid > norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 > > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid > norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 > > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid > norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 > > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid > norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 > > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid > norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 > > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid > norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 > > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid > norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 > > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid > norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 > > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid > norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 > > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid > norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 > > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid > norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 > > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid > norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 > > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid > norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 > > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid > norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 > > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid > norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 > > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid > norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 > > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid > norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 > > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid > norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 > > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid > norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 > > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid > norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 > > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid > norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 > > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid > norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 > > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid > norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 > > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid > norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 > > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid > norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 > > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid > norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 > > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid > norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 > > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid > norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 > > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid > norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 > > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid > norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 > > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid > norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 > > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid > norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 > > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid > norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 > > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid > norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 > > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid > norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 > > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid > norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 > > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid > norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 > > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid > norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 > > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid > norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 > > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid > norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 > > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid > norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 > > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid > norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 > > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid > norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 > > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid > norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 > > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid > norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 > > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid > norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 > > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid > norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 > > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid > norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 > > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid > norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 > > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid > norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 > > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid > norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 > > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid > norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 > > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid > norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 > > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid > norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 > > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid > norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 > > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid > norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 > > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid > norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 > > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid > norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 > > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid > norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 > > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid > norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 > > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid > norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 > > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid > norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 > > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid > norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 > > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid > norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 > > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid > norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 > > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid > norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 > > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid > norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 > > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid > norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 > > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid > norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 > > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid > norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 > > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid > norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 > > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid > norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 > > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid > norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 > > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid > norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 > > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid > norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 > > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid > norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 > > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid > norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 > > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid > norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 > > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid > norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 > > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid > norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 > > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid > norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 > > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid > norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 > > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid > norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 > > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid > norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 > > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid > norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 > > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid > norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 > > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid > norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 > > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid > norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 > > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid > norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 > > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid > norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 > > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid > norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 > > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid > norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 > > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid > norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 > > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid > norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 > > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid > norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 > > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid > norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 > > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid > norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 > > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid > norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 > > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid > norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 > > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid > norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 > > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid > norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 > > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid > norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 > > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid > norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 > > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid > norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 > > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid > norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 > > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid > norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 > > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid > norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 > > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid > norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 > > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid > norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 > > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid > norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 > > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid > norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 > > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid > norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 > > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid > norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 > > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid > norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 > > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid > norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 > > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid > norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 > > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid > norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 > > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid > norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 > > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid > norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 > > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid > norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 > > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid > norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 > > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid > norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 > > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid > norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 > > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid > norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 > > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid > norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 > > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid > norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 > > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid > norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 > > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid > norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 > > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid > norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 > > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid > norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 > > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid > norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 > > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid > norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 > > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid > norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 > > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid > norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 > > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid > norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 > > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid > norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 > > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid > norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 > > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid > norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 > > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid > norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 > > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid > norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 > > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid > norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 > > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid > norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 > > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid > norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 > > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid > norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 > > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid > norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 > > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid > norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 > > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid > norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 > > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid > norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 > > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid > norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 > > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid > norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 > > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid > norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 > > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid > norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 > > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid > norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 > > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid > norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 > > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid > norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 > > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid > norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 > > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid > norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 > > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid > norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 > > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid > norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 > > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid > norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 > > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid > norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 > > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid > norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 > > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid > norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 > > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid > norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 > > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid > norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 > > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid > norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 > > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid > norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 > > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid > norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 > > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid > norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 > > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid > norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 > > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid > norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 > > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid > norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 > > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid > norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 > > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid > norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 > > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid > norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 > > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid > norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 > > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid > norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 > > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid > norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 > > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid > norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 > > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid > norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 > > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid > norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 > > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid > norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 > > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid > norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 > > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid > norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 > > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid > norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 > > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid > norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 > > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid > norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 > > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid > norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 > > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid > norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 > > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid > norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 > > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid > norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 > > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid > norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 > > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid > norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 > > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid > norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 > > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid > norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 > > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid > norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 > > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid > norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 > > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid > norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 > > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid > norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 > > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid > norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 > > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid > norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 > > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid > norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 > > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid > norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 > > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid > norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 > > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid > norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 > > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid > norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 > > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid > norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 > > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid > norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 > > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid > norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 > > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid > norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 > > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid > norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 > > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid > norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 > > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid > norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 > > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid > norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 > > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid > norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 > > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid > norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 > > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid > norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 > > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid > norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 > > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid > norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 > > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid > norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 > > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid > norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 > > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid > norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 > > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid > norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 > > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid > norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 > > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid > norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 > > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid > norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 > > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid > norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 > > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid > norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 > > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid > norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 > > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid > norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 > > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid > norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 > > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid > norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 > > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid > norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 > > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid > norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 > > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid > norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 > > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid > norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 > > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid > norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 > > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid > norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 > > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid > norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 > > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid > norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 > > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid > norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 > > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid > norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 > > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid > norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 > > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid > norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 > > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid > norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 > > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid > norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 > > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid > norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 > > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid > norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 > > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid > norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 > > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid > norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 > > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid > norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 > > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid > norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 > > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid > norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 > > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid > norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 > > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid > norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 > > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid > norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 > > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid > norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 > > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid > norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 > > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid > norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 > > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid > norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 > > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid > norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 > > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid > norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 > > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid > norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 > > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid > norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 > > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid > norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 > > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid > norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 > > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid > norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 > > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid > norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 > > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid > norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 > > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid > norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 > > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid > norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 > > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid > norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 > > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid > norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 > > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid > norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 > > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid > norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 > > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid > norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 > > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid > norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 > > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid > norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 > > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid > norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 > > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid > norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 > > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid > norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 > > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid > norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 > > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid > norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 > > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid > norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 > > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid > norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 > > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid > norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 > > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid > norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 > > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid > norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 > > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid > norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 > > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid > norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 > > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid > norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 > > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid > norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 > > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid > norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 > > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid > norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 > > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid > norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 > > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid > norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 > > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid > norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 > > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid > norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 > > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid > norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 > > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid > norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 > > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid > norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 > > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid > norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 > > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid > norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 > > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid > norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 > > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid > norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 > > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid > norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 > > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid > norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 > > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid > norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 > > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid > norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 > > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid > norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 > > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid > norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 > > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid > norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 > > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid > norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 > > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid > norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 > > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid > norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 > > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid > norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 > > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid > norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 > > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid > norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 > > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid > norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 > > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid > norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 > > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid > norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 > > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid > norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 > > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid > norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 > > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid > norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 > > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid > norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 > > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid > norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 > > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid > norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 > > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid > norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 > > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid > norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 > > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid > norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 > > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid > norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 > > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid > norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 > > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid > norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 > > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid > norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 > > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid > norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 > > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid > norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 > > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid > norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 > > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid > norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 > > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid > norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 > > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid > norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 > > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid > norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 > > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid > norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 > > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid > norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 > > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid > norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 > > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid > norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 > > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid > norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 > > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid > norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 > > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid > norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 > > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid > norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 > > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid > norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 > > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid > norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 > > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid > norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 > > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid > norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 > > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid > norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 > > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid > norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 > > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid > norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 > > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid > norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 > > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid > norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 > > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid > norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 > > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid > norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 > > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid > norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 > > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid > norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 > > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid > norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 > > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid > norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 > > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid > norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 > > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid > norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 > > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid > norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 > > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid > norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 > > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid > norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 > > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid > norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 > > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid > norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 > > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid > norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 > > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid > norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 > > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid > norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 > > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid > norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 > > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid > norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 > > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid > norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 > > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid > norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 > > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid > norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 > > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid > norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 > > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid > norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 > > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid > norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 > > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid > norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 > > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid > norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 > > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid > norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 > > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid > norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 > > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid > norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 > > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid > norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 > > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid > norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 > > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid > norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 > > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid > norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 > > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid > norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 > > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid > norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 > > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid > norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 > > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid > norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 > > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid > norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 > > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid > norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 > > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid > norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 > > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid > norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 > > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid > norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 > > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid > norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 > > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid > norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 > > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid > norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 > > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid > norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 > > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid > norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 > > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid > norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 > > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid > norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 > > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid > norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 > > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid > norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 > > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid > norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 > > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid > norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 > > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid > norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 > > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid > norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 > > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid > norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 > > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid > norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 > > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid > norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 > > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid > norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 > > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid > norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 > > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid > norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 > > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid > norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 > > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid > norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 > > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid > norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 > > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid > norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 > > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid > norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 > > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid > norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 > > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid > norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 > > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid > norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 > > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid > norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 > > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid > norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 > > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid > norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 > > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid > norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 > > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid > norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 > > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid > norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 > > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid > norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 > > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid > norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 > > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid > norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 > > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid > norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 > > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid > norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 > > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid > norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 > > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid > norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 > > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid > norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 > > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid > norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 > > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid > norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 > > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid > norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 > > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid > norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 > > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid > norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 > > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid > norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 > > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid > norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 > > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid > norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 > > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid > norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 > > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid > norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 > > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid > norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 > > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid > norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 > > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid > norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 > > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid > norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 > > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid > norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 > > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid > norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 > > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid > norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 > > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid > norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 > > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid > norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 > > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid > norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 > > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid > norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 > > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid > norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 > > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid > norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 > > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid > norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 > > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid > norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 > > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid > norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 > > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid > norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 > > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid > norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 > > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid > norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 > > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid > norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 > > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid > norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 > > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid > norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 > > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid > norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 > > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid > norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 > > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid > norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 > > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid > norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 > > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid > norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 > > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid > norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 > > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid > norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 > > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid > norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 > > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid > norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 > > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid > norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 > > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid > norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 > > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid > norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 > > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid > norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 > > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid > norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 > > > > > > > > > > > > > > > > > > > > > > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : > > > > > > > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u and > c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for > each field. Then try replacing the direct solvers LU with hypre BoomerAMG > first one at a time. > > > > > > > > > > Let us know how it goes and we'll make additional suggestions, > > > > > > > > > > Barry > > > > > > > > > > > > > > > > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > > > > > > > > > > > Hi Barry, > > > > > > > > > > > > (1) > > > > > > I am basically solving the equilibrium coupled with phase field > equation: > > > > > > > > > > > > 1-D example > > > > > > u is displacement and c is phase-field parameter. > > > > > > > > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 > > > > > > > > > > > > phase-field equation: 2*G_c*L*(\Delta > c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 > > > > > > > > > > > > I solve the above 2 equations coupled. > > > > > > it is the formulation for quasi-static fracture problem, where > G_c is the critical energy release rate and L is the length scale in > phase-field method (both constant). > > > > > > > > > > > > The free energy I am using now is > > > > > > 1-D: > > > > > > > > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > > > > > > > > > > > > > > > > it is not convex w.r.t u and c simultaneously. > > > > > > > > > > > > (2) > > > > > > > > > > > > with an appropriate step size. Newton's method usually converges > with 5 iteration, and I can see the quadratic convergence of Newton's > method. > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > Thanks, > > > > > > Josh > > > > > > > > > > > > > > > > > > > > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > > > > > > > > > > > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L > wrote: > > > > > > > > > > > > > > Hi, > > > > > > > > > > > > > > I am using GRMES to solve the linear systems within Newton > Raphson. > > > > > > > I am using finite element method to solve fracture problem > with phase field method.(the formulation gives symmetric but indefinite > hessian so can't use CG) > > > > > > > > > > > > What exact equations are you using for the phase field > method? > > > > > > > > > > > > With the direct LU solver roughly how many iterations does > your Newton's method take? > > > > > > > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > The total iteration number to solve one linear system is often > very large( > 2000) even for a small sized problem(120K degree of freedom). > I've tried different preconditioner, but it doesn't help a lot. I have > checked my hessian and right hand side, and sure they are correct. > > > > > > > > > > > > > > I think it might stem from the great difference in element > size(max/min=100) and damage stiffness around crack. > > > > > > > > > > > > > > Anyone has idea to reduce the number of iteration? > > > > > > > > > > > > > > Now, I get away with it by using LU, which is not ideal for > large size problem (I will have to run it in the future) > > > > > > > > > > > > > > > > > > > > > Thanks, > > > > > > > Josh > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From ysjosh.lo at gmail.com Mon Aug 13 10:24:58 2018 From: ysjosh.lo at gmail.com (Josh L) Date: Mon, 13 Aug 2018 10:24:58 -0500 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: Hi Matt, Yes, the diagonal term is set to 1.0 Thanks, Josh 2018-08-13 9:13 GMT-05:00 Matthew Knepley : > On Sun, Aug 12, 2018 at 11:02 PM Smith, Barry F. > wrote: > >> >> Sending this to PETSc users because someone else (Mark?) will know why >> the Eigen estimator fails at iteration 0. >> > > Are you sure its the estimator? That should be GMRES, but the error is > coming from Chebyshev. > > You are remembering to put something on the diagonal of the zeroed rows, > right? > > Matt > > >> I notice you are using a real old version of PETSc, for GAMG which is >> a fast moving component of PETSc this may fail. You really should work with >> the latest version of PETSc. Why aren't you? >> >> Barry >> >> >> > On Aug 12, 2018, at 9:25 PM, Josh L wrote: >> > >> > Hi Barry, >> > >> > I set the near null space following the example, but I get error when >> solving it with -pc_type gamg(no error if solving with default PC). >> > Moreover, there will be no error if I don't call >> VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space >> will not affect iteration number. >> > >> > Is it because the way I set Dirichlet boundary conditions? >> > I just zero out the corresponding row and modify right hand size. >> > There is no Neumann bc. >> > >> > >> > Thanks, >> > >> > The following is the error I get >> > >> > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > [0]PETSC ERROR: Petsc has generated inconsistent data >> > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at iteration 0 >> > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 >> > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell >> named nid00009 by yslo Sun Aug 12 21:14:17 2018 >> > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 >> --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages >> --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 >> --with-scalar-type=real --with-shared-libraries=1 --with-precision=double >> --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 >> --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack >> --with-spai=1 --download-spai --with-sundials=1 --download-sundials >> --with-hdf5=1 --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 >> --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis >> --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack >> --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles >> --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 >> --download-superlu_dist --with-superlu=1 --download-superlu >> --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis >> --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/16.0.1.150/ >> compilers_and_libraries_2016.1.150/linux/mkl --CFLAGS="-xhost -O2 -g" >> --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" >> > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >> impls/cheby/cheby.c >> > [0]PETSC ERROR: #2 KSPSolve() line 656 in /opt/apps/intel16/cray_mpich_ >> 7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >> > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #7 PCApply_MG() line 343 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #8 PCApply() line 482 in /opt/apps/intel16/cray_mpich_ >> 7_3/petsc/3.7/src/ksp/pc/interface/precon.c >> > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/ >> private/kspimpl.h >> > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itres.c >> > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >> impls/gmres/gmres.c >> > [0]PETSC ERROR: #12 KSPSolve() line 656 in /opt/apps/intel16/cray_mpich_ >> 7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >> > >> > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : >> > >> > >> > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: >> > > >> > > >> > > >> > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : >> > > >> > > >> > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: >> > > > >> > > > Hi Barry, >> > > > >> > > > I use the example ex49 of KSP(linear elasticity problem), and it's >> output of ksp monitor is the same as my reduced problem, so I think my code >> is correct , at least for the reduced problem. >> > > >> > > Are you using -pc_type gamg ? >> > > >> > > No, just with GMRES and default PC. >> > > strangely, with gamg, the final solution is still the same but >> ksp output becomes different between my code and petsc example. >> > > with -pc_type gamg, my code take 35 iteration and petsc example >> takes only 7. >> > >> > You should use GAMG for elasticity type problems. Does you code set >> the near null space like the example does? >> > >> > > >> > > Thanks. >> > > >> > > >> > > > >> > > > Within a Newton's method, several linear system(Ax=b) is solved, >> and b is the residual vector whose norm becomes smaller and smaller. >> > > > Should I change rtol for KSP ? since ||b|| is reducing, and >> converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is >> rarely satisfied ) >> > > > I observe that for the first linear solve in Newton's method, >> iterative solver converges with okay number of iteration >> > > > , but for the following linear solve, iterative solver takes more >> and more iterations. >> > > >> > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 >> > > >> > > Try also -ksp_pc_side right >> > > >> > > >> > > Barry >> > > >> > > >> > > > >> > > > >> > > > Thanks, >> > > > Josh >> > > > >> > > > >> > > > >> > > > >> > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : >> > > > >> > > > Ok, PCGAMG should work well for linear elasticity so on your >> reduced problem use -pc_type gamg then the group (Mark) will have specific >> suggestions for options. We want to see about 20 iterations for >> "well-behaved" linear elasticity problems. >> > > > >> > > > Barry >> > > > >> > > > >> > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: >> > > > > >> > > > > Hi Barry, >> > > > > >> > > > > Thanks for your help. >> > > > > >> > > > > I removed the phase field from my formulation by setting all >> corresponding degrees of freedom as Dirichlet boundary condition, so >> > > > > my formulation becomes simply linear elastic. >> > > > > Then I use CG for KSP and algebraic multigrid for precondiitoner. >> For a 150K dofs problem, the linear solver converges with 200s >> iteration(still too much I think), but with GMRES it again takes 2000 >> iteration to converge. with GMRES and default PC, it barely converges >> within 10K iteration. >> > > > > >> > > > > I will double check my hessian. below is the ksp monitor output >> from GMRES and gamg PC for first 500 iteration. >> > > > > >> > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid >> norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 >> > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid >> norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 >> > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid >> norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 >> > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid >> norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 >> > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid >> norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 >> > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid >> norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 >> > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid >> norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 >> > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid >> norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 >> > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid >> norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 >> > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid >> norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 >> > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid >> norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 >> > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid >> norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 >> > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid >> norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 >> > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid >> norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 >> > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid >> norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 >> > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid >> norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 >> > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid >> norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 >> > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid >> norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 >> > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid >> norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 >> > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid >> norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 >> > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid >> norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 >> > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid >> norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 >> > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid >> norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 >> > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid >> norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 >> > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid >> norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 >> > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid >> norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 >> > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid >> norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 >> > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid >> norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 >> > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid >> norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 >> > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid >> norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 >> > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid >> norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 >> > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid >> norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 >> > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid >> norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 >> > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid >> norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 >> > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid >> norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 >> > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid >> norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 >> > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid >> norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 >> > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid >> norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 >> > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid >> norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 >> > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid >> norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 >> > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid >> norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 >> > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid >> norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 >> > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid >> norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 >> > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid >> norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 >> > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid >> norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 >> > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid >> norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 >> > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid >> norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 >> > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid >> norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 >> > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid >> norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 >> > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid >> norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 >> > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid >> norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 >> > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid >> norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 >> > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid >> norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 >> > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid >> norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 >> > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid >> norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 >> > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid >> norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 >> > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid >> norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 >> > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid >> norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 >> > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid >> norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 >> > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid >> norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 >> > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid >> norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 >> > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid >> norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 >> > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid >> norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 >> > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid >> norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 >> > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid >> norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 >> > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid >> norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 >> > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid >> norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 >> > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid >> norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 >> > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid >> norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 >> > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid >> norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 >> > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid >> norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 >> > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid >> norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 >> > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid >> norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 >> > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid >> norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 >> > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid >> norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 >> > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid >> norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 >> > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid >> norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 >> > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid >> norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 >> > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid >> norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 >> > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid >> norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 >> > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid >> norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 >> > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid >> norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 >> > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid >> norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 >> > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid >> norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 >> > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid >> norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 >> > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid >> norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 >> > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid >> norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 >> > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid >> norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 >> > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid >> norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 >> > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid >> norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 >> > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid >> norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 >> > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid >> norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 >> > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid >> norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 >> > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid >> norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 >> > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid >> norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 >> > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid >> norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 >> > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid >> norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 >> > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid >> norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 >> > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid >> norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 >> > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid >> norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 >> > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid >> norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 >> > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid >> norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 >> > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid >> norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 >> > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid >> norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 >> > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid >> norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 >> > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid >> norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 >> > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid >> norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 >> > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid >> norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 >> > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid >> norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 >> > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid >> norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 >> > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid >> norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 >> > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid >> norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 >> > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid >> norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 >> > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid >> norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 >> > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid >> norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 >> > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid >> norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 >> > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid >> norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 >> > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid >> norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 >> > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid >> norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 >> > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid >> norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 >> > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid >> norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 >> > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid >> norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 >> > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid >> norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 >> > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid >> norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 >> > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid >> norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 >> > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid >> norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 >> > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid >> norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 >> > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid >> norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 >> > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid >> norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 >> > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid >> norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 >> > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid >> norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 >> > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid >> norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 >> > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid >> norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 >> > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid >> norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 >> > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid >> norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 >> > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid >> norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 >> > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid >> norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 >> > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid >> norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 >> > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid >> norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 >> > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid >> norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 >> > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid >> norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 >> > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid >> norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 >> > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid >> norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 >> > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid >> norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 >> > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid >> norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 >> > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid >> norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 >> > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid >> norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 >> > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid >> norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 >> > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid >> norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 >> > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid >> norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 >> > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid >> norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 >> > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid >> norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 >> > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid >> norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 >> > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid >> norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 >> > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid >> norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 >> > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid >> norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 >> > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid >> norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 >> > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid >> norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 >> > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid >> norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 >> > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid >> norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 >> > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid >> norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 >> > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid >> norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 >> > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid >> norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 >> > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid >> norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 >> > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid >> norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 >> > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid >> norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 >> > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid >> norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 >> > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid >> norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 >> > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid >> norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 >> > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid >> norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 >> > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid >> norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 >> > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid >> norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 >> > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid >> norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 >> > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid >> norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 >> > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid >> norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 >> > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid >> norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 >> > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid >> norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 >> > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid >> norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 >> > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid >> norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 >> > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid >> norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 >> > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid >> norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 >> > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid >> norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 >> > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid >> norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 >> > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid >> norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 >> > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid >> norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 >> > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid >> norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 >> > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid >> norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 >> > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid >> norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 >> > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid >> norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 >> > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid >> norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 >> > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid >> norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 >> > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid >> norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 >> > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid >> norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 >> > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid >> norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 >> > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid >> norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 >> > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid >> norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 >> > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid >> norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 >> > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid >> norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 >> > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid >> norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 >> > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid >> norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 >> > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid >> norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 >> > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid >> norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 >> > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid >> norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 >> > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid >> norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 >> > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid >> norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 >> > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid >> norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 >> > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid >> norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 >> > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid >> norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 >> > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid >> norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 >> > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid >> norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 >> > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid >> norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 >> > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid >> norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 >> > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid >> norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 >> > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid >> norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 >> > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid >> norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 >> > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid >> norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 >> > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid >> norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 >> > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid >> norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 >> > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid >> norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 >> > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid >> norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 >> > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid >> norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 >> > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid >> norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 >> > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid >> norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 >> > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid >> norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 >> > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid >> norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 >> > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid >> norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 >> > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid >> norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 >> > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid >> norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 >> > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid >> norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 >> > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid >> norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 >> > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid >> norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 >> > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid >> norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 >> > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid >> norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 >> > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid >> norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 >> > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid >> norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 >> > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid >> norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 >> > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid >> norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 >> > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid >> norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 >> > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid >> norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 >> > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid >> norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 >> > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid >> norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 >> > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid >> norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 >> > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid >> norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 >> > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid >> norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 >> > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid >> norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 >> > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid >> norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 >> > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid >> norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 >> > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid >> norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 >> > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid >> norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 >> > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid >> norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 >> > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid >> norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 >> > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid >> norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 >> > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid >> norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 >> > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid >> norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 >> > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid >> norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 >> > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid >> norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 >> > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid >> norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 >> > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid >> norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 >> > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid >> norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 >> > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid >> norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 >> > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid >> norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 >> > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid >> norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 >> > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid >> norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 >> > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid >> norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 >> > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid >> norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 >> > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid >> norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 >> > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid >> norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 >> > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid >> norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 >> > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid >> norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 >> > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid >> norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 >> > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid >> norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 >> > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid >> norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 >> > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid >> norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 >> > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid >> norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 >> > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid >> norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 >> > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid >> norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 >> > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid >> norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 >> > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid >> norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 >> > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid >> norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 >> > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid >> norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 >> > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid >> norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 >> > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid >> norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 >> > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid >> norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 >> > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid >> norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 >> > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid >> norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 >> > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid >> norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 >> > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid >> norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 >> > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid >> norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 >> > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid >> norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 >> > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid >> norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 >> > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid >> norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 >> > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid >> norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 >> > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid >> norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 >> > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid >> norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 >> > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid >> norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 >> > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid >> norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 >> > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid >> norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 >> > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid >> norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 >> > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid >> norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 >> > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid >> norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 >> > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid >> norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 >> > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid >> norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 >> > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid >> norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 >> > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid >> norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 >> > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid >> norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 >> > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid >> norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 >> > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid >> norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 >> > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid >> norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 >> > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid >> norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 >> > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid >> norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 >> > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid >> norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 >> > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid >> norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 >> > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid >> norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 >> > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid >> norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 >> > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid >> norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 >> > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid >> norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 >> > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid >> norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 >> > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid >> norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 >> > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid >> norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 >> > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid >> norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 >> > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid >> norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 >> > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid >> norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 >> > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid >> norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 >> > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid >> norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 >> > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid >> norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 >> > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid >> norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 >> > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid >> norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 >> > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid >> norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 >> > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid >> norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 >> > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid >> norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 >> > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid >> norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 >> > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid >> norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 >> > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid >> norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 >> > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid >> norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 >> > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid >> norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 >> > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid >> norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 >> > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid >> norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 >> > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid >> norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 >> > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid >> norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 >> > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid >> norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 >> > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid >> norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 >> > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid >> norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 >> > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid >> norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 >> > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid >> norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 >> > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid >> norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 >> > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid >> norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 >> > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid >> norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 >> > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid >> norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 >> > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid >> norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 >> > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid >> norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 >> > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid >> norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 >> > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid >> norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 >> > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid >> norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 >> > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid >> norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 >> > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid >> norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 >> > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid >> norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 >> > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid >> norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 >> > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid >> norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 >> > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid >> norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 >> > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid >> norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 >> > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid >> norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 >> > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid >> norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 >> > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid >> norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 >> > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid >> norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 >> > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid >> norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 >> > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid >> norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 >> > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid >> norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 >> > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid >> norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 >> > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid >> norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 >> > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid >> norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 >> > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid >> norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 >> > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid >> norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 >> > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid >> norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 >> > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid >> norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 >> > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid >> norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 >> > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid >> norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 >> > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid >> norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 >> > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid >> norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 >> > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid >> norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 >> > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid >> norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 >> > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid >> norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 >> > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid >> norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 >> > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid >> norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 >> > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid >> norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 >> > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid >> norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 >> > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid >> norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 >> > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid >> norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 >> > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid >> norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 >> > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid >> norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 >> > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid >> norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 >> > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid >> norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 >> > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid >> norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 >> > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid >> norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 >> > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid >> norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 >> > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid >> norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 >> > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid >> norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 >> > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid >> norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 >> > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid >> norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 >> > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid >> norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 >> > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid >> norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 >> > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid >> norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 >> > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid >> norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 >> > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid >> norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 >> > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid >> norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 >> > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid >> norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 >> > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid >> norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 >> > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid >> norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 >> > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid >> norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 >> > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid >> norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 >> > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid >> norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 >> > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid >> norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 >> > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid >> norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 >> > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid >> norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 >> > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid >> norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 >> > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid >> norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 >> > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid >> norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 >> > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid >> norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 >> > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid >> norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 >> > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid >> norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 >> > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid >> norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 >> > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid >> norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 >> > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid >> norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 >> > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid >> norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 >> > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid >> norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 >> > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid >> norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 >> > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid >> norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 >> > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid >> norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 >> > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid >> norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 >> > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid >> norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 >> > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid >> norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 >> > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid >> norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 >> > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid >> norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 >> > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid >> norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 >> > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid >> norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 >> > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid >> norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 >> > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid >> norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 >> > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid >> norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 >> > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid >> norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 >> > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid >> norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 >> > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid >> norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 >> > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid >> norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 >> > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid >> norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 >> > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid >> norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 >> > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid >> norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 >> > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid >> norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 >> > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid >> norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 >> > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid >> norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 >> > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid >> norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 >> > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid >> norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 >> > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid >> norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 >> > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid >> norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 >> > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid >> norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 >> > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid >> norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 >> > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid >> norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 >> > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid >> norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 >> > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid >> norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 >> > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid >> norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 >> > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid >> norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 >> > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid >> norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 >> > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid >> norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 >> > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid >> norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 >> > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid >> norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 >> > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid >> norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 >> > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid >> norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 >> > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid >> norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 >> > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid >> norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 >> > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid >> norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 >> > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid >> norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 >> > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid >> norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 >> > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid >> norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 >> > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid >> norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 >> > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid >> norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 >> > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid >> norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 >> > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid >> norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 >> > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid >> norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 >> > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid >> norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 >> > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid >> norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 >> > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid >> norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 >> > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid >> norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 >> > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid >> norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 >> > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid >> norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 >> > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid >> norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 >> > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid >> norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 >> > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid >> norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 >> > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid >> norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 >> > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid >> norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 >> > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid >> norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 >> > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid >> norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 >> > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid >> norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 >> > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid >> norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 >> > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid >> norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 >> > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid >> norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 >> > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid >> norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 >> > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid >> norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 >> > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid >> norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 >> > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid >> norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 >> > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid >> norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 >> > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid >> norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 >> > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid >> norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 >> > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid >> norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 >> > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid >> norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : >> > > > > >> > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u >> and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) >> for each field. Then try replacing the direct solvers LU with hypre >> BoomerAMG first one at a time. >> > > > > >> > > > > Let us know how it goes and we'll make additional suggestions, >> > > > > >> > > > > Barry >> > > > > >> > > > > >> > > > > > On Aug 6, 2018, at 12:58 PM, Josh L >> wrote: >> > > > > > >> > > > > > Hi Barry, >> > > > > > >> > > > > > (1) >> > > > > > I am basically solving the equilibrium coupled with phase field >> equation: >> > > > > > >> > > > > > 1-D example >> > > > > > u is displacement and c is phase-field parameter. >> > > > > > >> > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 >> > > > > > >> > > > > > phase-field equation: 2*G_c*L*(\Delta >> c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 >> > > > > > >> > > > > > I solve the above 2 equations coupled. >> > > > > > it is the formulation for quasi-static fracture problem, where >> G_c is the critical energy release rate and L is the length scale in >> phase-field method (both constant). >> > > > > > >> > > > > > The free energy I am using now is >> > > > > > 1-D: >> > > > > > >> > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c >> > > > > > >> > > > > > >> > > > > > it is not convex w.r.t u and c simultaneously. >> > > > > > >> > > > > > (2) >> > > > > > >> > > > > > with an appropriate step size. Newton's method usually >> converges with 5 iteration, and I can see the quadratic convergence of >> Newton's method. >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > Thanks, >> > > > > > Josh >> > > > > > >> > > > > > >> > > > > > >> > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. > >: >> > > > > > >> > > > > > >> > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L >> wrote: >> > > > > > > >> > > > > > > Hi, >> > > > > > > >> > > > > > > I am using GRMES to solve the linear systems within Newton >> Raphson. >> > > > > > > I am using finite element method to solve fracture problem >> with phase field method.(the formulation gives symmetric but indefinite >> hessian so can't use CG) >> > > > > > >> > > > > > What exact equations are you using for the phase field >> method? >> > > > > > >> > > > > > With the direct LU solver roughly how many iterations does >> your Newton's method take? >> > > > > > >> > > > > > >> > > > > > Barry >> > > > > > >> > > > > > > >> > > > > > > The total iteration number to solve one linear system is >> often very large( > 2000) even for a small sized problem(120K degree of >> freedom). I've tried different preconditioner, but it doesn't help a lot. >> I have checked my hessian and right hand side, and sure they are correct. >> > > > > > > >> > > > > > > I think it might stem from the great difference in element >> size(max/min=100) and damage stiffness around crack. >> > > > > > > >> > > > > > > Anyone has idea to reduce the number of iteration? >> > > > > > > >> > > > > > > Now, I get away with it by using LU, which is not ideal for >> large size problem (I will have to run it in the future) >> > > > > > > >> > > > > > > >> > > > > > > Thanks, >> > > > > > > Josh >> > > > > > > >> > > > > > >> > > > > > >> > > > > >> > > > > >> > > > >> > > > >> > >> > >> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Aug 13 10:28:37 2018 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 13 Aug 2018 11:28:37 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: On Mon, Aug 13, 2018 at 11:25 AM Josh L wrote: > Hi Matt, > > Yes, the diagonal term is set to 1.0 > Can you send the matrix and rhs? I think you can output them using -ksp_view_mat binary:system.bin -ksp_view_rhs binary:system.bin::append and then we can run exactly what you do in KSP ex10. Thanks, Matt > Thanks, > Josh > > > 2018-08-13 9:13 GMT-05:00 Matthew Knepley : > >> On Sun, Aug 12, 2018 at 11:02 PM Smith, Barry F. >> wrote: >> >>> >>> Sending this to PETSc users because someone else (Mark?) will know why >>> the Eigen estimator fails at iteration 0. >>> >> >> Are you sure its the estimator? That should be GMRES, but the error is >> coming from Chebyshev. >> >> You are remembering to put something on the diagonal of the zeroed rows, >> right? >> >> Matt >> >> >>> I notice you are using a real old version of PETSc, for GAMG which is >>> a fast moving component of PETSc this may fail. You really should work with >>> the latest version of PETSc. Why aren't you? >>> >>> Barry >>> >>> >>> > On Aug 12, 2018, at 9:25 PM, Josh L wrote: >>> > >>> > Hi Barry, >>> > >>> > I set the near null space following the example, but I get error when >>> solving it with -pc_type gamg(no error if solving with default PC). >>> > Moreover, there will be no error if I don't call >>> VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space >>> will not affect iteration number. >>> > >>> > Is it because the way I set Dirichlet boundary conditions? >>> > I just zero out the corresponding row and modify right hand size. >>> > There is no Neumann bc. >>> > >>> > >>> > Thanks, >>> > >>> > The following is the error I get >>> > >>> > [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> > [0]PETSC ERROR: Petsc has generated inconsistent data >>> > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at iteration >>> 0 >>> > [0]PETSC ERROR: See >>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>> shooting. >>> > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 >>> > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell >>> named nid00009 by yslo Sun Aug 12 21:14:17 2018 >>> > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 >>> --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages >>> --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 >>> --with-scalar-type=real --with-shared-libraries=1 --with-precision=double >>> --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 >>> --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack >>> --with-spai=1 --download-spai --with-sundials=1 --download-sundials >>> --with-hdf5=1 >>> --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 >>> --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis >>> --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack >>> --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles >>> --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 >>> --download-superlu_dist --with-superlu=1 --download-superlu >>> --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis >>> --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/ >>> 16.0.1.150/compilers_and_libraries_2016.1.150/linux/mkl >>> --CFLAGS="-xhost -O2 -g" --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" >>> > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/cheby/cheby.c >>> > [0]PETSC ERROR: #2 KSPSolve() line 656 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >>> > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #7 PCApply_MG() line 343 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #8 PCApply() line 482 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/interface/precon.c >>> > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/private/kspimpl.h >>> > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itres.c >>> > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/gmres/gmres.c >>> > [0]PETSC ERROR: #12 KSPSolve() line 656 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >>> > >>> > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : >>> > >>> > >>> > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: >>> > > >>> > > >>> > > >>> > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : >>> > > >>> > > >>> > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: >>> > > > >>> > > > Hi Barry, >>> > > > >>> > > > I use the example ex49 of KSP(linear elasticity problem), and it's >>> output of ksp monitor is the same as my reduced problem, so I think my code >>> is correct , at least for the reduced problem. >>> > > >>> > > Are you using -pc_type gamg ? >>> > > >>> > > No, just with GMRES and default PC. >>> > > strangely, with gamg, the final solution is still the same but >>> ksp output becomes different between my code and petsc example. >>> > > with -pc_type gamg, my code take 35 iteration and petsc >>> example takes only 7. >>> > >>> > You should use GAMG for elasticity type problems. Does you code set >>> the near null space like the example does? >>> > >>> > > >>> > > Thanks. >>> > > >>> > > >>> > > > >>> > > > Within a Newton's method, several linear system(Ax=b) is solved, >>> and b is the residual vector whose norm becomes smaller and smaller. >>> > > > Should I change rtol for KSP ? since ||b|| is reducing, and >>> converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is >>> rarely satisfied ) >>> > > > I observe that for the first linear solve in Newton's method, >>> iterative solver converges with okay number of iteration >>> > > > , but for the following linear solve, iterative solver takes more >>> and more iterations. >>> > > >>> > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 >>> > > >>> > > Try also -ksp_pc_side right >>> > > >>> > > >>> > > Barry >>> > > >>> > > >>> > > > >>> > > > >>> > > > Thanks, >>> > > > Josh >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : >>> > > > >>> > > > Ok, PCGAMG should work well for linear elasticity so on your >>> reduced problem use -pc_type gamg then the group (Mark) will have specific >>> suggestions for options. We want to see about 20 iterations for >>> "well-behaved" linear elasticity problems. >>> > > > >>> > > > Barry >>> > > > >>> > > > >>> > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: >>> > > > > >>> > > > > Hi Barry, >>> > > > > >>> > > > > Thanks for your help. >>> > > > > >>> > > > > I removed the phase field from my formulation by setting all >>> corresponding degrees of freedom as Dirichlet boundary condition, so >>> > > > > my formulation becomes simply linear elastic. >>> > > > > Then I use CG for KSP and algebraic multigrid for >>> precondiitoner. For a 150K dofs problem, the linear solver converges with >>> 200s iteration(still too much I think), but with GMRES it again takes 2000 >>> iteration to converge. with GMRES and default PC, it barely converges >>> within 10K iteration. >>> > > > > >>> > > > > I will double check my hessian. below is the ksp monitor output >>> from GMRES and gamg PC for first 500 iteration. >>> > > > > >>> > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid >>> norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 >>> > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid >>> norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 >>> > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid >>> norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 >>> > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid >>> norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 >>> > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid >>> norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 >>> > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid >>> norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 >>> > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid >>> norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 >>> > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid >>> norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 >>> > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid >>> norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 >>> > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid >>> norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 >>> > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid >>> norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 >>> > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid >>> norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 >>> > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid >>> norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 >>> > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid >>> norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 >>> > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid >>> norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 >>> > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid >>> norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 >>> > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid >>> norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 >>> > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid >>> norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 >>> > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid >>> norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 >>> > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid >>> norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 >>> > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid >>> norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 >>> > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid >>> norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 >>> > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid >>> norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 >>> > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid >>> norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 >>> > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid >>> norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 >>> > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid >>> norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 >>> > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid >>> norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 >>> > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid >>> norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 >>> > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid >>> norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 >>> > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid >>> norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 >>> > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid >>> norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 >>> > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid >>> norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 >>> > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid >>> norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 >>> > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid >>> norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 >>> > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid >>> norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 >>> > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid >>> norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 >>> > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid >>> norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 >>> > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid >>> norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 >>> > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid >>> norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 >>> > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid >>> norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 >>> > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid >>> norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 >>> > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid >>> norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 >>> > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid >>> norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 >>> > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid >>> norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 >>> > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid >>> norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 >>> > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid >>> norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 >>> > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid >>> norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 >>> > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid >>> norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 >>> > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid >>> norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 >>> > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid >>> norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 >>> > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid >>> norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 >>> > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid >>> norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 >>> > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid >>> norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 >>> > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid >>> norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 >>> > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid >>> norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 >>> > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid >>> norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 >>> > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid >>> norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 >>> > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid >>> norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 >>> > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid >>> norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 >>> > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid >>> norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 >>> > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid >>> norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 >>> > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid >>> norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 >>> > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid >>> norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 >>> > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid >>> norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 >>> > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid >>> norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 >>> > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid >>> norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 >>> > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid >>> norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 >>> > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid >>> norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 >>> > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid >>> norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 >>> > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid >>> norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 >>> > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid >>> norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 >>> > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid >>> norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 >>> > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid >>> norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 >>> > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid >>> norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 >>> > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid >>> norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 >>> > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid >>> norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 >>> > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid >>> norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 >>> > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid >>> norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 >>> > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid >>> norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 >>> > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid >>> norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 >>> > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid >>> norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 >>> > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid >>> norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 >>> > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid >>> norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 >>> > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid >>> norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 >>> > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid >>> norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 >>> > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid >>> norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 >>> > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid >>> norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 >>> > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid >>> norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 >>> > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid >>> norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 >>> > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid >>> norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 >>> > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid >>> norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 >>> > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid >>> norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 >>> > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid >>> norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 >>> > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid >>> norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 >>> > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid >>> norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 >>> > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid >>> norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 >>> > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid >>> norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 >>> > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid >>> norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 >>> > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid >>> norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 >>> > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid >>> norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 >>> > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid >>> norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 >>> > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid >>> norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 >>> > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid >>> norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 >>> > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid >>> norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 >>> > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid >>> norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 >>> > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid >>> norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 >>> > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid >>> norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 >>> > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid >>> norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 >>> > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid >>> norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 >>> > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid >>> norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 >>> > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid >>> norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 >>> > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid >>> norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 >>> > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid >>> norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 >>> > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid >>> norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 >>> > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid >>> norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 >>> > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid >>> norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 >>> > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid >>> norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 >>> > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid >>> norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 >>> > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid >>> norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 >>> > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid >>> norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 >>> > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid >>> norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 >>> > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid >>> norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 >>> > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid >>> norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 >>> > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid >>> norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 >>> > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid >>> norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 >>> > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid >>> norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 >>> > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid >>> norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 >>> > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid >>> norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 >>> > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid >>> norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 >>> > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid >>> norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 >>> > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid >>> norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 >>> > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid >>> norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 >>> > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid >>> norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 >>> > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid >>> norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 >>> > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid >>> norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 >>> > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid >>> norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 >>> > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid >>> norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 >>> > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid >>> norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 >>> > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid >>> norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 >>> > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid >>> norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 >>> > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid >>> norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 >>> > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid >>> norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 >>> > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid >>> norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 >>> > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid >>> norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 >>> > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid >>> norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 >>> > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid >>> norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 >>> > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid >>> norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 >>> > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid >>> norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 >>> > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid >>> norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 >>> > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid >>> norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 >>> > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid >>> norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 >>> > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid >>> norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 >>> > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid >>> norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 >>> > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid >>> norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 >>> > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid >>> norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 >>> > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid >>> norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 >>> > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid >>> norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 >>> > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid >>> norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 >>> > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid >>> norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 >>> > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid >>> norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 >>> > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid >>> norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 >>> > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid >>> norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 >>> > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid >>> norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 >>> > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid >>> norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 >>> > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid >>> norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 >>> > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid >>> norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 >>> > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid >>> norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 >>> > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid >>> norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 >>> > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid >>> norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 >>> > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid >>> norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 >>> > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid >>> norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 >>> > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid >>> norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 >>> > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid >>> norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 >>> > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid >>> norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 >>> > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid >>> norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 >>> > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid >>> norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 >>> > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid >>> norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 >>> > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid >>> norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 >>> > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid >>> norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 >>> > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid >>> norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 >>> > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid >>> norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 >>> > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid >>> norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 >>> > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid >>> norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 >>> > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid >>> norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 >>> > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid >>> norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 >>> > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid >>> norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 >>> > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid >>> norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 >>> > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid >>> norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 >>> > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid >>> norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 >>> > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid >>> norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 >>> > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid >>> norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 >>> > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid >>> norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 >>> > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid >>> norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 >>> > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid >>> norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 >>> > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid >>> norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 >>> > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid >>> norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 >>> > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid >>> norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 >>> > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid >>> norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 >>> > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid >>> norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 >>> > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid >>> norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 >>> > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid >>> norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 >>> > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid >>> norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 >>> > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid >>> norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 >>> > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid >>> norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 >>> > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid >>> norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 >>> > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid >>> norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 >>> > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid >>> norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 >>> > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid >>> norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 >>> > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid >>> norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 >>> > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid >>> norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 >>> > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid >>> norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 >>> > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid >>> norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 >>> > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid >>> norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 >>> > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid >>> norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 >>> > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid >>> norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 >>> > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid >>> norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 >>> > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid >>> norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 >>> > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid >>> norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 >>> > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid >>> norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 >>> > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid >>> norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 >>> > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid >>> norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 >>> > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid >>> norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 >>> > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid >>> norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 >>> > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid >>> norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 >>> > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid >>> norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 >>> > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid >>> norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 >>> > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid >>> norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 >>> > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid >>> norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 >>> > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid >>> norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 >>> > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid >>> norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 >>> > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid >>> norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 >>> > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid >>> norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 >>> > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid >>> norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 >>> > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid >>> norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 >>> > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid >>> norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 >>> > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid >>> norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 >>> > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid >>> norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 >>> > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid >>> norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 >>> > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid >>> norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 >>> > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid >>> norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 >>> > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid >>> norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 >>> > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid >>> norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 >>> > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid >>> norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 >>> > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid >>> norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 >>> > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid >>> norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 >>> > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid >>> norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 >>> > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid >>> norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 >>> > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid >>> norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 >>> > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid >>> norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 >>> > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid >>> norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 >>> > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid >>> norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 >>> > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid >>> norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 >>> > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid >>> norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 >>> > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid >>> norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 >>> > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid >>> norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 >>> > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid >>> norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 >>> > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid >>> norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 >>> > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid >>> norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 >>> > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid >>> norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 >>> > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid >>> norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 >>> > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid >>> norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 >>> > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid >>> norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 >>> > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid >>> norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 >>> > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid >>> norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 >>> > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid >>> norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 >>> > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid >>> norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 >>> > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid >>> norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 >>> > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid >>> norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 >>> > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid >>> norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 >>> > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid >>> norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 >>> > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid >>> norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 >>> > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid >>> norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 >>> > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid >>> norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 >>> > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid >>> norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 >>> > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid >>> norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 >>> > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid >>> norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 >>> > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid >>> norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 >>> > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid >>> norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 >>> > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid >>> norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 >>> > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid >>> norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 >>> > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid >>> norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 >>> > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid >>> norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 >>> > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid >>> norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 >>> > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid >>> norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 >>> > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid >>> norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 >>> > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid >>> norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 >>> > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid >>> norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 >>> > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid >>> norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 >>> > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid >>> norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 >>> > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid >>> norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 >>> > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid >>> norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 >>> > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid >>> norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 >>> > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid >>> norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 >>> > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid >>> norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 >>> > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid >>> norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 >>> > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid >>> norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 >>> > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid >>> norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 >>> > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid >>> norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 >>> > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid >>> norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 >>> > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid >>> norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 >>> > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid >>> norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 >>> > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid >>> norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 >>> > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid >>> norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 >>> > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid >>> norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 >>> > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid >>> norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 >>> > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid >>> norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 >>> > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid >>> norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 >>> > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid >>> norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 >>> > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid >>> norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 >>> > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid >>> norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 >>> > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid >>> norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 >>> > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid >>> norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 >>> > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid >>> norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 >>> > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid >>> norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 >>> > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid >>> norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 >>> > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid >>> norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 >>> > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid >>> norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 >>> > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid >>> norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 >>> > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid >>> norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 >>> > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid >>> norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 >>> > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid >>> norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 >>> > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid >>> norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 >>> > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid >>> norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 >>> > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid >>> norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 >>> > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid >>> norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 >>> > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid >>> norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 >>> > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid >>> norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 >>> > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid >>> norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 >>> > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid >>> norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 >>> > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid >>> norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 >>> > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid >>> norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 >>> > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid >>> norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 >>> > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid >>> norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 >>> > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid >>> norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 >>> > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid >>> norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 >>> > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid >>> norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 >>> > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid >>> norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 >>> > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid >>> norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 >>> > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid >>> norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 >>> > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid >>> norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 >>> > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid >>> norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 >>> > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid >>> norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 >>> > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid >>> norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 >>> > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid >>> norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 >>> > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid >>> norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 >>> > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid >>> norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 >>> > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid >>> norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 >>> > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid >>> norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 >>> > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid >>> norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 >>> > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid >>> norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 >>> > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid >>> norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 >>> > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid >>> norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 >>> > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid >>> norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 >>> > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid >>> norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 >>> > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid >>> norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 >>> > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid >>> norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 >>> > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid >>> norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 >>> > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid >>> norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 >>> > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid >>> norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 >>> > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid >>> norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 >>> > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid >>> norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 >>> > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid >>> norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 >>> > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid >>> norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 >>> > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid >>> norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 >>> > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid >>> norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 >>> > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid >>> norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 >>> > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid >>> norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 >>> > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid >>> norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 >>> > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid >>> norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 >>> > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid >>> norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 >>> > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid >>> norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 >>> > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid >>> norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 >>> > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid >>> norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 >>> > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid >>> norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 >>> > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid >>> norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 >>> > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid >>> norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 >>> > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid >>> norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 >>> > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid >>> norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 >>> > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid >>> norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 >>> > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid >>> norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 >>> > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid >>> norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 >>> > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid >>> norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 >>> > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid >>> norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 >>> > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid >>> norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 >>> > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid >>> norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 >>> > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid >>> norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 >>> > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid >>> norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 >>> > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid >>> norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 >>> > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid >>> norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 >>> > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid >>> norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 >>> > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid >>> norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 >>> > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid >>> norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 >>> > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid >>> norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 >>> > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid >>> norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 >>> > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid >>> norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 >>> > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid >>> norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 >>> > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid >>> norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 >>> > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid >>> norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 >>> > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid >>> norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 >>> > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid >>> norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 >>> > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid >>> norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 >>> > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid >>> norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 >>> > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid >>> norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 >>> > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid >>> norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 >>> > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid >>> norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 >>> > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid >>> norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 >>> > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid >>> norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 >>> > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid >>> norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 >>> > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid >>> norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 >>> > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid >>> norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 >>> > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid >>> norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 >>> > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid >>> norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 >>> > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid >>> norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 >>> > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid >>> norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 >>> > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid >>> norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 >>> > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid >>> norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 >>> > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid >>> norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 >>> > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid >>> norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 >>> > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid >>> norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 >>> > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid >>> norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 >>> > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid >>> norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 >>> > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid >>> norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 >>> > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid >>> norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 >>> > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid >>> norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 >>> > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid >>> norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 >>> > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid >>> norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 >>> > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid >>> norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 >>> > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid >>> norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 >>> > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid >>> norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 >>> > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid >>> norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 >>> > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid >>> norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 >>> > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid >>> norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 >>> > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid >>> norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 >>> > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid >>> norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 >>> > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid >>> norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 >>> > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid >>> norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 >>> > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid >>> norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 >>> > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid >>> norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 >>> > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid >>> norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 >>> > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid >>> norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 >>> > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid >>> norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 >>> > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid >>> norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 >>> > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid >>> norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 >>> > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid >>> norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 >>> > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid >>> norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 >>> > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid >>> norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 >>> > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid >>> norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 >>> > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid >>> norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 >>> > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid >>> norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 >>> > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid >>> norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 >>> > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid >>> norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 >>> > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid >>> norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 >>> > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid >>> norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 >>> > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid >>> norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 >>> > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid >>> norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 >>> > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid >>> norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 >>> > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid >>> norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 >>> > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid >>> norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 >>> > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid >>> norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 >>> > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid >>> norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 >>> > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid >>> norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 >>> > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid >>> norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 >>> > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid >>> norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 >>> > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid >>> norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 >>> > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid >>> norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 >>> > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid >>> norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 >>> > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid >>> norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 >>> > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid >>> norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 >>> > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid >>> norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 >>> > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid >>> norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 >>> > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid >>> norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 >>> > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid >>> norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 >>> > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid >>> norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 >>> > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid >>> norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 >>> > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid >>> norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 >>> > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid >>> norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 >>> > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid >>> norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 >>> > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid >>> norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 >>> > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid >>> norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 >>> > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid >>> norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 >>> > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid >>> norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 >>> > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid >>> norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 >>> > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid >>> norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 >>> > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid >>> norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 >>> > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid >>> norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 >>> > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid >>> norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 >>> > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid >>> norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 >>> > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid >>> norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 >>> > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid >>> norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 >>> > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid >>> norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 >>> > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid >>> norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 >>> > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid >>> norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 >>> > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid >>> norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 >>> > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid >>> norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 >>> > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid >>> norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 >>> > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid >>> norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 >>> > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid >>> norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 >>> > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid >>> norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 >>> > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid >>> norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 >>> > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid >>> norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 >>> > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid >>> norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : >>> > > > > >>> > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u >>> and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) >>> for each field. Then try replacing the direct solvers LU with hypre >>> BoomerAMG first one at a time. >>> > > > > >>> > > > > Let us know how it goes and we'll make additional >>> suggestions, >>> > > > > >>> > > > > Barry >>> > > > > >>> > > > > >>> > > > > > On Aug 6, 2018, at 12:58 PM, Josh L >>> wrote: >>> > > > > > >>> > > > > > Hi Barry, >>> > > > > > >>> > > > > > (1) >>> > > > > > I am basically solving the equilibrium coupled with phase >>> field equation: >>> > > > > > >>> > > > > > 1-D example >>> > > > > > u is displacement and c is phase-field parameter. >>> > > > > > >>> > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 >>> > > > > > >>> > > > > > phase-field equation: 2*G_c*L*(\Delta >>> c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 >>> > > > > > >>> > > > > > I solve the above 2 equations coupled. >>> > > > > > it is the formulation for quasi-static fracture problem, where >>> G_c is the critical energy release rate and L is the length scale in >>> phase-field method (both constant). >>> > > > > > >>> > > > > > The free energy I am using now is >>> > > > > > 1-D: >>> > > > > > >>> > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c >>> > > > > > >>> > > > > > >>> > > > > > it is not convex w.r.t u and c simultaneously. >>> > > > > > >>> > > > > > (2) >>> > > > > > >>> > > > > > with an appropriate step size. Newton's method usually >>> converges with 5 iteration, and I can see the quadratic convergence of >>> Newton's method. >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > Thanks, >>> > > > > > Josh >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. >> >: >>> > > > > > >>> > > > > > >>> > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L >>> wrote: >>> > > > > > > >>> > > > > > > Hi, >>> > > > > > > >>> > > > > > > I am using GRMES to solve the linear systems within Newton >>> Raphson. >>> > > > > > > I am using finite element method to solve fracture problem >>> with phase field method.(the formulation gives symmetric but indefinite >>> hessian so can't use CG) >>> > > > > > >>> > > > > > What exact equations are you using for the phase field >>> method? >>> > > > > > >>> > > > > > With the direct LU solver roughly how many iterations >>> does your Newton's method take? >>> > > > > > >>> > > > > > >>> > > > > > Barry >>> > > > > > >>> > > > > > > >>> > > > > > > The total iteration number to solve one linear system is >>> often very large( > 2000) even for a small sized problem(120K degree of >>> freedom). I've tried different preconditioner, but it doesn't help a lot. >>> I have checked my hessian and right hand side, and sure they are correct. >>> > > > > > > >>> > > > > > > I think it might stem from the great difference in element >>> size(max/min=100) and damage stiffness around crack. >>> > > > > > > >>> > > > > > > Anyone has idea to reduce the number of iteration? >>> > > > > > > >>> > > > > > > Now, I get away with it by using LU, which is not ideal for >>> large size problem (I will have to run it in the future) >>> > > > > > > >>> > > > > > > >>> > > > > > > Thanks, >>> > > > > > > Josh >>> > > > > > > >>> > > > > > >>> > > > > > >>> > > > > >>> > > > > >>> > > > >>> > > > >>> > >>> > >>> >>> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From florian.kauer at koalo.de Tue Aug 14 09:06:00 2018 From: florian.kauer at koalo.de (Florian Kauer) Date: Tue, 14 Aug 2018 16:06:00 +0200 Subject: [petsc-users] Max color value exeeds 65535 limit Message-ID: <5f546463-0465-d7a7-b23f-8e5e5bdf26bd@koalo.de> Hi, I was just testing out if my calculations also work for several 10000 variables and got the following error. Is this a fundamental limit with very large (or complex) systems of equations or does it hint to a bug/wrong configuration in my program? Everything works fine for smaller systems. [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Max color value exeeds 65535 limit. This number is unrealistic. Perhaps a bug in code? Current max: 65535 user rewuested: 65536 [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Release Version 3.8.4, unknown [0]PETSC ERROR: ./csma_model on a linux-gnu-c-debug named h3a-srv-crunchie by cto7138 Tue Aug 14 15:59:57 2018 [0]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mpich --download-fblaslapack [0]PETSC ERROR: #1 ISColoringCreate() line 268 in /home/cto7138/petsc/src/vec/is/is/utils/iscoloring.c [0]PETSC ERROR: #2 MatColoringPatch_SeqAIJ_Inode() line 2715 in /home/cto7138/petsc/src/mat/impls/aij/seq/inode.c [0]PETSC ERROR: #3 MatColoringPatch() line 7566 in /home/cto7138/petsc/src/mat/interface/matrix.c [0]PETSC ERROR: #4 MatColoringApply_SL() line 101 in /home/cto7138/petsc/src/mat/color/impls/minpack/color.c [0]PETSC ERROR: #5 MatColoringApply() line 360 in /home/cto7138/petsc/src/mat/color/interface/matcoloring.c [0]PETSC ERROR: #6 SNESComputeJacobianDefaultColor() line 81 in /home/cto7138/petsc/src/snes/interface/snesj2.c [0]PETSC ERROR: #7 SNESComputeJacobian() line 2360 in /home/cto7138/petsc/src/snes/interface/snes.c [0]PETSC ERROR: #8 SNESSolve_NEWTONLS() line 222 in /home/cto7138/petsc/src/snes/impls/ls/ls.c [0]PETSC ERROR: #9 SNESSolve() line 4131 in /home/cto7138/petsc/src/snes/interface/snes.c [0]PETSC ERROR: #10 main() line 401 in /home/cto7138/evaluation/analyticalmultihop/src/csma_model/csma_model.cpp [0]PETSC ERROR: PETSc Option Table entries: [0]PETSC ERROR: --experiment /home/cto7138/evaluation/results/analytical-csma/inverse-model/21341_95/000/experiment_CSMA.json [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- Greetings, Florian From mfadams at lbl.gov Tue Aug 14 09:14:18 2018 From: mfadams at lbl.gov (Mark Adams) Date: Tue, 14 Aug 2018 10:14:18 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: On Sun, Aug 12, 2018 at 11:02 PM Smith, Barry F. wrote: > > Sending this to PETSc users because someone else (Mark?) will know why > the Eigen estimator fails at iteration 0. > This is failing in the smoothers eigen estimator. I think the RHS is garbage because you are getting INF/NAN before the iteration starts (0 iterations and there is no initial guess). FWIW, If you use -ksp_chebyshev_esteig_noisy, Cheby will generate a random RHS and will get past the eigen estimator if in fact this is the problem. If the code runs without VecSetBlockSize then, all I can think of is, there is memory corruption ... when you create vec_coord, do you give it a size m = 2*N ? Note, you should be able to reproduce this problem with '-ksp_type chebyshev' to get GAMG out of the way. > I notice you are using a real old version of PETSc, for GAMG which is a > fast moving component of PETSc this may fail. You really should work with > the latest version of PETSc. Why aren't you? > > Barry > > > > On Aug 12, 2018, at 9:25 PM, Josh L wrote: > > > > Hi Barry, > > > > I set the near null space following the example, but I get error when > solving it with -pc_type gamg(no error if solving with default PC). > > Moreover, there will be no error if I don't call > VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space > will not affect iteration number. > > > > Is it because the way I set Dirichlet boundary conditions? > > I just zero out the corresponding row and modify right hand size. > > There is no Neumann bc. > > > > > > Thanks, > > > > The following is the error I get > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [0]PETSC ERROR: Petsc has generated inconsistent data > > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at iteration 0 > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 > > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell named > nid00009 by yslo Sun Aug 12 21:14:17 2018 > > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 > --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages > --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 > --with-scalar-type=real --with-shared-libraries=1 --with-precision=double > --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 > --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack > --with-spai=1 --download-spai --with-sundials=1 --download-sundials > --with-hdf5=1 > --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 > --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis > --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack > --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles > --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 > --download-superlu_dist --with-superlu=1 --download-superlu > --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis > --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/ > 16.0.1.150/compilers_and_libraries_2016.1.150/linux/mkl --CFLAGS="-xhost > -O2 -g" --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" > > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/cheby/cheby.c > > [0]PETSC ERROR: #2 KSPSolve() line 656 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c > > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > > [0]PETSC ERROR: #7 PCApply_MG() line 343 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c > > [0]PETSC ERROR: #8 PCApply() line 482 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/interface/precon.c > > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/private/kspimpl.h > > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itres.c > > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/gmres/gmres.c > > [0]PETSC ERROR: #12 KSPSolve() line 656 in > /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c > > > > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : > > > > > > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: > > > > > > > > > > > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : > > > > > > > > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: > > > > > > > > Hi Barry, > > > > > > > > I use the example ex49 of KSP(linear elasticity problem), and it's > output of ksp monitor is the same as my reduced problem, so I think my code > is correct , at least for the reduced problem. > > > > > > Are you using -pc_type gamg ? > > > > > > No, just with GMRES and default PC. > > > strangely, with gamg, the final solution is still the same but > ksp output becomes different between my code and petsc example. > > > with -pc_type gamg, my code take 35 iteration and petsc example > takes only 7. > > > > You should use GAMG for elasticity type problems. Does you code set > the near null space like the example does? > > > > > > > > Thanks. > > > > > > > > > > > > > > Within a Newton's method, several linear system(Ax=b) is solved, and > b is the residual vector whose norm becomes smaller and smaller. > > > > Should I change rtol for KSP ? since ||b|| is reducing, and converge > requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is rarely > satisfied ) > > > > I observe that for the first linear solve in Newton's method, > iterative solver converges with okay number of iteration > > > > , but for the following linear solve, iterative solver takes more > and more iterations. > > > > > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 > > > > > > Try also -ksp_pc_side right > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > Thanks, > > > > Josh > > > > > > > > > > > > > > > > > > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : > > > > > > > > Ok, PCGAMG should work well for linear elasticity so on your > reduced problem use -pc_type gamg then the group (Mark) will have specific > suggestions for options. We want to see about 20 iterations for > "well-behaved" linear elasticity problems. > > > > > > > > Barry > > > > > > > > > > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: > > > > > > > > > > Hi Barry, > > > > > > > > > > Thanks for your help. > > > > > > > > > > I removed the phase field from my formulation by setting all > corresponding degrees of freedom as Dirichlet boundary condition, so > > > > > my formulation becomes simply linear elastic. > > > > > Then I use CG for KSP and algebraic multigrid for precondiitoner. > For a 150K dofs problem, the linear solver converges with 200s > iteration(still too much I think), but with GMRES it again takes 2000 > iteration to converge. with GMRES and default PC, it barely converges > within 10K iteration. > > > > > > > > > > I will double check my hessian. below is the ksp monitor output > from GMRES and gamg PC for first 500 iteration. > > > > > > > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid > norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 > > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid > norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 > > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid > norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 > > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid > norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 > > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid > norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 > > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid > norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 > > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid > norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 > > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid > norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 > > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid > norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 > > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid > norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 > > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid > norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 > > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid > norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 > > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid > norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 > > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid > norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 > > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid > norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 > > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid > norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 > > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid > norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 > > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid > norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 > > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid > norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 > > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid > norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 > > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid > norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 > > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid > norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 > > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid > norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 > > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid > norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 > > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid > norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 > > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid > norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 > > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid > norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 > > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid > norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 > > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid > norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 > > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid > norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 > > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid > norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 > > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid > norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 > > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid > norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 > > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid > norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 > > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid > norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 > > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid > norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 > > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid > norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 > > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid > norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 > > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid > norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 > > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid > norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 > > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid > norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 > > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid > norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 > > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid > norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 > > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid > norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 > > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid > norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 > > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid > norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 > > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid > norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 > > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid > norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 > > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid > norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 > > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid > norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 > > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid > norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 > > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid > norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 > > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid > norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 > > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid > norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 > > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid > norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 > > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid > norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 > > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid > norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 > > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid > norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 > > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid > norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 > > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid > norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 > > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid > norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 > > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid > norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 > > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid > norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 > > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid > norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 > > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid > norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 > > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid > norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 > > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid > norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 > > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid > norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 > > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid > norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 > > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid > norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 > > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid > norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 > > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid > norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 > > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid > norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 > > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid > norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 > > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid > norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 > > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid > norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 > > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid > norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 > > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid > norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 > > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid > norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 > > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid > norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 > > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid > norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 > > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid > norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 > > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid > norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 > > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid > norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 > > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid > norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 > > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid > norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 > > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid > norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 > > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid > norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 > > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid > norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 > > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid > norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 > > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid > norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 > > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid > norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 > > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid > norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 > > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid > norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 > > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid > norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 > > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid > norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 > > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid > norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 > > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid > norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 > > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid > norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 > > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid > norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 > > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid > norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 > > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid > norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 > > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid > norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 > > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid > norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 > > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid > norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 > > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid > norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 > > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid > norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 > > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid > norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 > > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid > norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 > > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid > norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 > > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid > norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 > > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid > norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 > > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid > norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 > > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid > norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 > > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid > norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 > > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid > norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 > > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid > norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 > > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid > norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 > > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid > norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 > > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid > norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 > > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid > norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 > > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid > norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 > > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid > norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 > > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid > norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 > > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid > norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 > > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid > norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 > > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid > norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 > > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid > norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 > > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid > norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 > > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid > norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 > > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid > norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 > > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid > norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 > > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid > norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 > > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid > norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 > > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid > norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 > > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid > norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 > > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid > norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 > > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid > norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 > > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid > norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 > > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid > norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 > > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid > norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 > > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid > norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 > > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid > norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 > > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid > norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 > > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid > norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 > > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid > norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 > > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid > norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 > > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid > norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 > > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid > norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 > > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid > norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 > > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid > norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 > > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid > norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 > > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid > norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 > > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid > norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 > > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid > norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 > > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid > norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 > > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid > norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 > > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid > norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 > > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid > norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 > > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid > norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 > > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid > norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 > > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid > norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 > > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid > norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 > > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid > norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 > > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid > norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 > > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid > norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 > > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid > norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 > > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid > norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 > > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid > norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 > > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid > norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 > > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid > norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 > > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid > norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 > > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid > norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 > > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid > norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 > > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid > norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 > > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid > norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 > > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid > norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 > > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid > norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 > > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid > norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 > > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid > norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 > > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid > norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 > > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid > norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 > > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid > norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 > > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid > norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 > > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid > norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 > > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid > norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 > > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid > norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 > > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid > norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 > > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid > norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 > > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid > norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 > > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid > norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 > > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid > norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 > > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid > norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 > > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid > norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 > > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid > norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 > > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid > norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 > > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid > norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 > > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid > norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 > > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid > norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 > > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid > norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 > > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid > norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 > > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid > norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 > > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid > norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 > > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid > norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 > > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid > norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 > > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid > norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 > > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid > norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 > > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid > norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 > > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid > norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 > > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid > norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 > > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid > norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 > > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid > norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 > > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid > norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 > > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid > norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 > > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid > norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 > > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid > norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 > > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid > norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 > > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid > norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 > > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid > norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 > > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid > norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 > > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid > norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 > > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid > norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 > > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid > norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 > > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid > norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 > > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid > norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 > > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid > norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 > > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid > norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 > > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid > norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 > > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid > norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 > > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid > norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 > > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid > norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 > > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid > norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 > > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid > norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 > > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid > norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 > > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid > norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 > > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid > norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 > > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid > norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 > > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid > norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 > > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid > norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 > > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid > norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 > > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid > norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 > > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid > norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 > > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid > norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 > > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid > norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 > > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid > norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 > > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid > norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 > > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid > norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 > > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid > norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 > > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid > norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 > > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid > norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 > > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid > norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 > > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid > norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 > > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid > norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 > > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid > norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 > > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid > norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 > > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid > norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 > > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid > norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 > > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid > norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 > > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid > norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 > > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid > norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 > > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid > norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 > > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid > norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 > > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid > norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 > > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid > norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 > > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid > norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 > > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid > norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 > > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid > norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 > > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid > norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 > > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid > norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 > > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid > norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 > > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid > norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 > > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid > norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 > > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid > norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 > > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid > norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 > > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid > norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 > > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid > norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 > > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid > norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 > > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid > norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 > > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid > norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 > > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid > norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 > > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid > norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 > > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid > norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 > > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid > norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 > > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid > norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 > > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid > norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 > > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid > norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 > > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid > norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 > > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid > norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 > > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid > norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 > > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid > norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 > > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid > norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 > > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid > norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 > > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid > norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 > > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid > norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 > > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid > norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 > > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid > norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 > > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid > norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 > > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid > norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 > > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid > norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 > > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid > norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 > > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid > norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 > > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid > norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 > > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid > norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 > > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid > norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 > > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid > norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 > > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid > norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 > > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid > norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 > > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid > norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 > > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid > norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 > > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid > norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 > > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid > norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 > > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid > norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 > > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid > norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 > > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid > norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 > > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid > norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 > > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid > norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 > > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid > norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 > > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid > norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 > > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid > norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 > > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid > norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 > > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid > norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 > > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid > norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 > > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid > norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 > > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid > norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 > > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid > norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 > > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid > norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 > > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid > norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 > > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid > norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 > > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid > norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 > > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid > norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 > > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid > norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 > > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid > norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 > > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid > norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 > > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid > norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 > > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid > norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 > > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid > norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 > > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid > norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 > > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid > norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 > > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid > norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 > > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid > norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 > > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid > norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 > > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid > norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 > > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid > norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 > > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid > norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 > > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid > norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 > > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid > norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 > > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid > norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 > > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid > norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 > > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid > norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 > > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid > norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 > > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid > norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 > > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid > norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 > > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid > norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 > > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid > norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 > > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid > norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 > > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid > norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 > > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid > norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 > > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid > norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 > > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid > norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 > > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid > norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 > > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid > norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 > > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid > norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 > > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid > norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 > > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid > norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 > > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid > norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 > > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid > norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 > > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid > norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 > > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid > norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 > > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid > norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 > > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid > norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 > > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid > norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 > > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid > norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 > > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid > norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 > > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid > norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 > > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid > norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 > > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid > norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 > > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid > norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 > > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid > norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 > > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid > norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 > > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid > norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 > > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid > norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 > > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid > norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 > > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid > norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 > > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid > norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 > > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid > norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 > > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid > norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 > > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid > norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 > > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid > norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 > > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid > norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 > > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid > norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 > > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid > norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 > > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid > norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 > > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid > norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 > > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid > norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 > > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid > norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 > > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid > norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 > > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid > norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 > > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid > norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 > > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid > norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 > > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid > norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 > > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid > norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 > > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid > norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 > > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid > norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 > > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid > norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 > > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid > norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 > > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid > norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 > > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid > norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 > > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid > norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 > > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid > norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 > > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid > norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 > > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid > norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 > > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid > norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 > > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid > norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 > > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid > norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 > > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid > norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 > > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid > norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 > > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid > norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 > > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid > norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 > > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid > norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 > > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid > norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 > > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid > norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 > > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid > norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 > > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid > norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 > > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid > norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 > > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid > norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 > > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid > norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 > > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid > norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 > > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid > norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 > > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid > norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 > > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid > norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 > > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid > norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 > > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid > norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 > > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid > norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 > > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid > norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 > > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid > norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 > > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid > norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 > > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid > norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 > > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid > norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 > > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid > norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 > > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid > norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 > > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid > norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 > > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid > norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 > > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid > norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 > > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid > norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 > > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid > norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 > > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid > norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 > > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid > norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 > > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid > norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 > > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid > norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 > > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid > norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 > > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid > norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 > > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid > norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 > > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid > norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 > > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid > norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 > > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid > norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 > > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid > norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 > > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid > norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 > > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid > norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 > > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid > norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 > > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid > norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 > > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid > norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 > > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid > norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 > > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid > norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 > > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid > norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 > > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid > norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 > > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid > norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 > > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid > norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 > > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid > norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 > > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid > norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 > > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid > norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 > > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid > norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 > > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid > norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 > > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid > norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 > > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid > norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 > > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid > norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 > > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid > norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 > > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid > norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 > > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid > norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 > > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid > norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 > > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid > norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 > > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid > norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 > > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid > norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 > > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid > norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 > > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid > norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 > > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid > norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 > > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid > norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 > > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid > norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 > > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid > norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 > > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid > norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 > > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid > norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 > > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid > norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 > > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid > norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 > > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid > norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 > > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid > norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 > > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid > norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 > > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid > norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 > > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid > norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 > > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid > norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 > > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid > norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 > > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid > norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 > > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid > norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 > > > > > > > > > > > > > > > > > > > > > > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : > > > > > > > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u and > c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) for > each field. Then try replacing the direct solvers LU with hypre BoomerAMG > first one at a time. > > > > > > > > > > Let us know how it goes and we'll make additional suggestions, > > > > > > > > > > Barry > > > > > > > > > > > > > > > > On Aug 6, 2018, at 12:58 PM, Josh L wrote: > > > > > > > > > > > > Hi Barry, > > > > > > > > > > > > (1) > > > > > > I am basically solving the equilibrium coupled with phase field > equation: > > > > > > > > > > > > 1-D example > > > > > > u is displacement and c is phase-field parameter. > > > > > > > > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 > > > > > > > > > > > > phase-field equation: 2*G_c*L*(\Delta > c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 > > > > > > > > > > > > I solve the above 2 equations coupled. > > > > > > it is the formulation for quasi-static fracture problem, where > G_c is the critical energy release rate and L is the length scale in > phase-field method (both constant). > > > > > > > > > > > > The free energy I am using now is > > > > > > 1-D: > > > > > > > > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c > > > > > > > > > > > > > > > > > > it is not convex w.r.t u and c simultaneously. > > > > > > > > > > > > (2) > > > > > > > > > > > > with an appropriate step size. Newton's method usually converges > with 5 iteration, and I can see the quadratic convergence of Newton's > method. > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > Thanks, > > > > > > Josh > > > > > > > > > > > > > > > > > > > > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. : > > > > > > > > > > > > > > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L > wrote: > > > > > > > > > > > > > > Hi, > > > > > > > > > > > > > > I am using GRMES to solve the linear systems within Newton > Raphson. > > > > > > > I am using finite element method to solve fracture problem > with phase field method.(the formulation gives symmetric but indefinite > hessian so can't use CG) > > > > > > > > > > > > What exact equations are you using for the phase field > method? > > > > > > > > > > > > With the direct LU solver roughly how many iterations does > your Newton's method take? > > > > > > > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > The total iteration number to solve one linear system is often > very large( > 2000) even for a small sized problem(120K degree of freedom). > I've tried different preconditioner, but it doesn't help a lot. I have > checked my hessian and right hand side, and sure they are correct. > > > > > > > > > > > > > > I think it might stem from the great difference in element > size(max/min=100) and damage stiffness around crack. > > > > > > > > > > > > > > Anyone has idea to reduce the number of iteration? > > > > > > > > > > > > > > Now, I get away with it by using LU, which is not ideal for > large size problem (I will have to run it in the future) > > > > > > > > > > > > > > > > > > > > > Thanks, > > > > > > > Josh > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Tue Aug 14 11:02:17 2018 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 14 Aug 2018 12:02:17 -0400 Subject: [petsc-users] Max color value exeeds 65535 limit In-Reply-To: <5f546463-0465-d7a7-b23f-8e5e5bdf26bd@koalo.de> References: <5f546463-0465-d7a7-b23f-8e5e5bdf26bd@koalo.de> Message-ID: On Tue, Aug 14, 2018 at 10:12 AM Florian Kauer wrote: > Hi, > I was just testing out if my calculations also work for several 10000 > variables and got the following error. Is this a fundamental limit with > very large (or complex) systems of equations or does it hint to a bug/wrong > configuration in my program? Everything works fine for smaller systems. > This is an artificial limit. However, you probably do not want to use that coloring. Is this matrix sparse? If so, I would try the greedy coloring based on the AIJ pattern. Thanks, Matt > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Max color value exeeds 65535 limit. This number is > unrealistic. Perhaps a bug in code? > Current max: 65535 user rewuested: 65536 > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Release Version 3.8.4, unknown > [0]PETSC ERROR: ./csma_model on a linux-gnu-c-debug named h3a-srv-crunchie > by cto7138 Tue Aug 14 15:59:57 2018 > [0]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ > --with-fc=gfortran --download-mpich --download-fblaslapack > [0]PETSC ERROR: #1 ISColoringCreate() line 268 in > /home/cto7138/petsc/src/vec/is/is/utils/iscoloring.c > [0]PETSC ERROR: #2 MatColoringPatch_SeqAIJ_Inode() line 2715 in > /home/cto7138/petsc/src/mat/impls/aij/seq/inode.c > [0]PETSC ERROR: #3 MatColoringPatch() line 7566 in > /home/cto7138/petsc/src/mat/interface/matrix.c > [0]PETSC ERROR: #4 MatColoringApply_SL() line 101 in > /home/cto7138/petsc/src/mat/color/impls/minpack/color.c > [0]PETSC ERROR: #5 MatColoringApply() line 360 in > /home/cto7138/petsc/src/mat/color/interface/matcoloring.c > [0]PETSC ERROR: #6 SNESComputeJacobianDefaultColor() line 81 in > /home/cto7138/petsc/src/snes/interface/snesj2.c > [0]PETSC ERROR: #7 SNESComputeJacobian() line 2360 in > /home/cto7138/petsc/src/snes/interface/snes.c > [0]PETSC ERROR: #8 SNESSolve_NEWTONLS() line 222 in > /home/cto7138/petsc/src/snes/impls/ls/ls.c > [0]PETSC ERROR: #9 SNESSolve() line 4131 in > /home/cto7138/petsc/src/snes/interface/snes.c > [0]PETSC ERROR: #10 main() line 401 in > /home/cto7138/evaluation/analyticalmultihop/src/csma_model/csma_model.cpp > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: --experiment > /home/cto7138/evaluation/results/analytical-csma/inverse-model/21341_95/000/experiment_CSMA.json > [0]PETSC ERROR: ----------------End of Error Message -------send entire > error message to petsc-maint at mcs.anl.gov---------- > > Greetings, > Florian > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Aug 14 11:09:40 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Tue, 14 Aug 2018 16:09:40 +0000 Subject: [petsc-users] Max color value exeeds 65535 limit In-Reply-To: <5f546463-0465-d7a7-b23f-8e5e5bdf26bd@koalo.de> References: <5f546463-0465-d7a7-b23f-8e5e5bdf26bd@koalo.de> Message-ID: <3B60A544-4BD0-4579-9B0F-97736EE0DE9F@anl.gov> Your "sparse" matrix is too dense to realistically use coloring to compute the Jacobian. Use instead SNESComputeJacobianDefault Barry > On Aug 14, 2018, at 9:06 AM, Florian Kauer wrote: > > Hi, > I was just testing out if my calculations also work for several 10000 variables and got the following error. Is this a fundamental limit with very large (or complex) systems of equations or does it hint to a bug/wrong configuration in my program? Everything works fine for smaller systems. > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Max color value exeeds 65535 limit. This number is unrealistic. Perhaps a bug in code? > Current max: 65535 user rewuested: 65536 > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Release Version 3.8.4, unknown > [0]PETSC ERROR: ./csma_model on a linux-gnu-c-debug named h3a-srv-crunchie by cto7138 Tue Aug 14 15:59:57 2018 > [0]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mpich --download-fblaslapack > [0]PETSC ERROR: #1 ISColoringCreate() line 268 in /home/cto7138/petsc/src/vec/is/is/utils/iscoloring.c > [0]PETSC ERROR: #2 MatColoringPatch_SeqAIJ_Inode() line 2715 in /home/cto7138/petsc/src/mat/impls/aij/seq/inode.c > [0]PETSC ERROR: #3 MatColoringPatch() line 7566 in /home/cto7138/petsc/src/mat/interface/matrix.c > [0]PETSC ERROR: #4 MatColoringApply_SL() line 101 in /home/cto7138/petsc/src/mat/color/impls/minpack/color.c > [0]PETSC ERROR: #5 MatColoringApply() line 360 in /home/cto7138/petsc/src/mat/color/interface/matcoloring.c > [0]PETSC ERROR: #6 SNESComputeJacobianDefaultColor() line 81 in /home/cto7138/petsc/src/snes/interface/snesj2.c > [0]PETSC ERROR: #7 SNESComputeJacobian() line 2360 in /home/cto7138/petsc/src/snes/interface/snes.c > [0]PETSC ERROR: #8 SNESSolve_NEWTONLS() line 222 in /home/cto7138/petsc/src/snes/impls/ls/ls.c > [0]PETSC ERROR: #9 SNESSolve() line 4131 in /home/cto7138/petsc/src/snes/interface/snes.c > [0]PETSC ERROR: #10 main() line 401 in /home/cto7138/evaluation/analyticalmultihop/src/csma_model/csma_model.cpp > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: --experiment /home/cto7138/evaluation/results/analytical-csma/inverse-model/21341_95/000/experiment_CSMA.json > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > > Greetings, > Florian From michael.wick.1980 at gmail.com Tue Aug 14 12:19:22 2018 From: michael.wick.1980 at gmail.com (Mike Wick) Date: Tue, 14 Aug 2018 10:19:22 -0700 Subject: [petsc-users] an error message related to nest matrix Message-ID: Hi: I have a simple code myself to learn the basic usage of nest matrix. It assembles a 3x3 nest matrix and solve with that nest matrix. I can run it without a preconditioner. Running the code with -pc_type fieldsplit just leads to an error message. I have no clue of what goes wrong. The message is in below. I also have my code attached. Thanks, M [0]PETSC ERROR: PetscTrFreeDefault() called from VecRestoreArray_Nest() line 678 in /home/lib/petsc-3.9.1-src/src/vec/vec/impls/nest/vecnest.c [0]PETSC ERROR: Block at address 0x2784ec8 is corrupted; cannot free; may be block not allocated with PetscMalloc() [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: Memory corruption: http://www.mcs.anl.gov/petsc/documentation/installation.html#valgrind [0]PETSC ERROR: Bad location or corrupted memory [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Release Version 3.9.1, Apr, 29, 2018 [0]PETSC ERROR: ./matnest on a named bacon by mike Tue Aug 14 10:03:56 2018 [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-make-np=12 --with-mpi-compilers=1 --with-mpi-dir=/home/lib/mpich-3.2/ --with-scalar-type=real --with-shared-libraries=1 --with-precision=double --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-plapack=1 --download-plapack --with-spai=1 --download-spai --with-sundials=1 --download-sundials --with-mumps=1 --download-mumps --with-scalapack=1 --download-scalapack --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 --download-superlu_dist --with-superlu=1 --download-superlu --with-zoltan=1 --download-zoltan=1 --with-debugging=yes --download-fblaslapack --with-ml=1 --download-ml --with-eigen=1 --download-eigen --prefix=~/lib/petsc-3.9.1-debug [0]PETSC ERROR: #1 PetscTrFreeDefault() line 269 in /home/lib/petsc-3.9.1-src/src/sys/memory/mtr.c [0]PETSC ERROR: #2 VecRestoreArray_Nest() line 678 in /home/lib/petsc-3.9.1-src/src/vec/vec/impls/nest/vecnest.c [0]PETSC ERROR: #3 VecRestoreArrayRead() line 1835 in /home/lib/petsc-3.9.1-src/src/vec/vec/interface/rvector.c [0]PETSC ERROR: #4 VecRestoreArrayPair() line 511 in /home/lib/petsc-3.9.1-src/include/petscvec.h [0]PETSC ERROR: #5 VecScatterBegin_SSToSS() line 671 in /home/lib/petsc-3.9.1-src/src/vec/vscat/impls/vscat.c [0]PETSC ERROR: #6 VecScatterBegin() line 1779 in /home/lib/petsc-3.9.1-src/src/vec/vscat/impls/vscat.c [0]PETSC ERROR: #7 PCApply_FieldSplit() line 1040 in /home/lib/petsc-3.9.1-src/src/ksp/pc/impls/fieldsplit/fieldsplit.c [0]PETSC ERROR: #8 PCApply() line 457 in /home/lib/petsc-3.9.1-src/src/ksp/pc/interface/precon.c [0]PETSC ERROR: #9 KSP_PCApply() line 276 in /home/lib/petsc-3.9.1-src/include/petsc/private/kspimpl.h [0]PETSC ERROR: #10 KSPInitialResidual() line 67 in /home/lib/petsc-3.9.1-src/src/ksp/ksp/interface/itres.c [0]PETSC ERROR: #11 KSPSolve_GMRES() line 233 in /home/lib/petsc-3.9.1-src/src/ksp/ksp/impls/gmres/gmres.c [0]PETSC ERROR: #12 KSPSolve() line 669 in /home/lib/petsc-3.9.1-src/src/ksp/ksp/interface/itfunc.c -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: test_nest_mat.cpp Type: text/x-c++src Size: 6143 bytes Desc: not available URL: From mvalera-w at sdsu.edu Tue Aug 14 14:54:23 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Tue, 14 Aug 2018 12:54:23 -0700 Subject: [petsc-users] Code break when PETSc not debugging Message-ID: Hello everyone, I am working on running part of my code in a GPU, recently i was able to run the whole model using one P100 GPU and one processor with good timing but using --with-debugging=1 as configure argument, With this in mind i compiled PETSc in a separate folder with the same exact flags except for --with-debugging=no instead to do some profiling, but this was enough to give segfault as an error after running the code, it looks the error happens just after solving the linear system, Any idea on why this may be happening? My configure options: ./configure PETSC_ARCH=cuda --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS='-O2' --CXXOPTFLAGS='-O2' --FOPTFLAGS='-O2' --with-shared-libraries=1 --with-debugging=no --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl My running arguments: mpirun -n 1 ./gcmLEP tc=TestCases/LockRelease/LE_401x6x101/ jid=cuda_dt0.1 -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view Thanks. -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Tue Aug 14 14:57:25 2018 From: jed at jedbrown.org (Jed Brown) Date: Tue, 14 Aug 2018 13:57:25 -0600 Subject: [petsc-users] Code break when PETSc not debugging In-Reply-To: References: Message-ID: <87wossafh6.fsf@jedbrown.org> Manuel Valera writes: > Hello everyone, > > I am working on running part of my code in a GPU, recently i was able to > run the whole model using one P100 GPU and one processor with good timing > but using --with-debugging=1 as configure argument, > > With this in mind i compiled PETSc in a separate folder with the same exact > flags except for --with-debugging=no instead to do some profiling, but this > was enough to give segfault as an error after running the code, it looks > the error happens just after solving the linear system, > > Any idea on why this may be happening? Run in a debugger and send a stack trace. > My configure options: > > ./configure PETSC_ARCH=cuda --with-mpi-dir=/usr/lib64/openmpi > --COPTFLAGS='-O2' --CXXOPTFLAGS='-O2' --FOPTFLAGS='-O2' > --with-shared-libraries=1 --with-debugging=no --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > My running arguments: > > mpirun -n 1 ./gcmLEP tc=TestCases/LockRelease/LE_401x6x101/ jid=cuda_dt0.1 > -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl > -log_view > > Thanks. From mvalera-w at sdsu.edu Tue Aug 14 16:09:01 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Tue, 14 Aug 2018 14:09:01 -0700 Subject: [petsc-users] Code break when PETSc not debugging In-Reply-To: <87wossafh6.fsf@jedbrown.org> References: <87wossafh6.fsf@jedbrown.org> Message-ID: Thanks Jed, I got the attached, it looks is coming from one of my routines CorrectU4Pressure.F90, what other information can i get from this log? Thanks, On Tue, Aug 14, 2018 at 12:57 PM, Jed Brown wrote: > Manuel Valera writes: > > > Hello everyone, > > > > I am working on running part of my code in a GPU, recently i was able to > > run the whole model using one P100 GPU and one processor with good timing > > but using --with-debugging=1 as configure argument, > > > > With this in mind i compiled PETSc in a separate folder with the same > exact > > flags except for --with-debugging=no instead to do some profiling, but > this > > was enough to give segfault as an error after running the code, it looks > > the error happens just after solving the linear system, > > > > Any idea on why this may be happening? > > Run in a debugger and send a stack trace. > > > My configure options: > > > > ./configure PETSC_ARCH=cuda --with-mpi-dir=/usr/lib64/openmpi > > --COPTFLAGS='-O2' --CXXOPTFLAGS='-O2' --FOPTFLAGS='-O2' > > --with-shared-libraries=1 --with-debugging=no --with-cuda=1 > > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > > --download-viennacl > > > > My running arguments: > > > > mpirun -n 1 ./gcmLEP tc=TestCases/LockRelease/LE_401x6x101/ > jid=cuda_dt0.1 > > -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl > > -log_view > > > > Thanks. > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: debug02.log Type: text/x-log Size: 2587 bytes Desc: not available URL: From jed at jedbrown.org Tue Aug 14 16:13:44 2018 From: jed at jedbrown.org (Jed Brown) Date: Tue, 14 Aug 2018 15:13:44 -0600 Subject: [petsc-users] Code break when PETSc not debugging In-Reply-To: References: <87wossafh6.fsf@jedbrown.org> Message-ID: <87mutoabxz.fsf@jedbrown.org> Manuel Valera writes: > Thanks Jed, > > I got the attached, it looks is coming from one of my routines > CorrectU4Pressure.F90, what other information can i get from this log? If you compile with debug info (COPTFLAGS=-g FOPTFLAGS=-g) you'll be able to see the source line that's causing this error. > Thanks, > > On Tue, Aug 14, 2018 at 12:57 PM, Jed Brown wrote: > >> Manuel Valera writes: >> >> > Hello everyone, >> > >> > I am working on running part of my code in a GPU, recently i was able to >> > run the whole model using one P100 GPU and one processor with good timing >> > but using --with-debugging=1 as configure argument, >> > >> > With this in mind i compiled PETSc in a separate folder with the same >> exact >> > flags except for --with-debugging=no instead to do some profiling, but >> this >> > was enough to give segfault as an error after running the code, it looks >> > the error happens just after solving the linear system, >> > >> > Any idea on why this may be happening? >> >> Run in a debugger and send a stack trace. >> >> > My configure options: >> > >> > ./configure PETSC_ARCH=cuda --with-mpi-dir=/usr/lib64/openmpi >> > --COPTFLAGS='-O2' --CXXOPTFLAGS='-O2' --FOPTFLAGS='-O2' >> > --with-shared-libraries=1 --with-debugging=no --with-cuda=1 >> > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> > --download-viennacl >> > >> > My running arguments: >> > >> > mpirun -n 1 ./gcmLEP tc=TestCases/LockRelease/LE_401x6x101/ >> jid=cuda_dt0.1 >> > -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl >> > -log_view >> > >> > Thanks. >> > Starting program: /usr/scratch/valera/ParGCCOM/./gcmLEP tc=TestCases/LockRelease/LE_401x6x101/ jid=cuda_test -dm_vec_type viennacl -dm_mat_type aijviennacl -ksp_type cg -pc_type saviennacl > [Thread debugging using libthread_db enabled] > Using host libthread_db library "/usr/lib64/libthread_db.so.1". > [New Thread 0x2aaac83b5700 (LWP 171597)] > [New Thread 0x2aaac93d2700 (LWP 171600)] > [New Thread 0x2aaac95e3700 (LWP 171604)] > [New Thread 0x2aaacbcc1700 (LWP 171612)] > [New Thread 0x2aaad6cee700 (LWP 171613)] > > Program received signal SIGSEGV, Segmentation fault. > 0x0000000000415730 in correct4pressure_ () > Missing separate debuginfos, use: debuginfo-install blas-3.4.2-8.el7.x86_64 cyrus-sasl-lib-2.1.26-20.el7_2.x86_64 glibc-2.17-196.el7_4.2.x86_64 hdf5-1.8.12-7.el7.x86_64 hwloc-libs-1.7-5.el7.x86_64 infinipath-psm-3.3-0.g6f42cdb1bb8.2.el7.x86_64 keyutils-libs-1.5.8-3.el7.x86_64 krb5-libs-1.13.2-12.el7_2.x86_64 lapack-3.4.2-8.el7.x86_64 libX11-1.6.5-1.el7.x86_64 libXau-1.0.8-2.1.el7.x86_64 libcom_err-1.42.9-7.el7.x86_64 libcurl-7.29.0-25.el7.centos.x86_64 libcxgb3-1.3.1-8.el7.x86_64 libcxgb4-1.3.5-3.el7.x86_64 libfabric-1.1.0-2.el7.x86_64 libgcc-4.8.5-16.el7_4.1.x86_64 libgfortran-4.8.5-16.el7_4.1.x86_64 libibumad-1.3.10.2-1.el7.x86_64 libibverbs-1.1.8-8.el7.x86_64 libidn-1.28-4.el7.x86_64 libipathverbs-1.3-2.el7.x86_64 libjpeg-turbo-1.2.90-5.el7.x86_64 libmlx4-1.0.6-5.el7.x86_64 libmlx5-1.0.2-1.el7.x86_64 libmthca-1.0.6-13.el7.x86_64 libnes-1.1.4-2.el7.x86_64 libnl3-3.2.28-4.el7.x86_64 libpciaccess-0.13.4-2.el7.x86_64 libquadmath-4.8.5-16.el7_4.1.x86_64 librdmacm-1.0.21-1.el7.x86_64 libselinux-2.2.2-6.el7.x86_64 libssh2-1.4.3-10.el7_2.1.x86_64 libstdc++-4.8.5-16.el7_4.1.x86_64 libxcb-1.12-1.el7.x86_64 libxml2-2.9.1-6.el7_2.2.x86_64 netcdf-4.3.3.1-5.el7.x86_64 netcdf-fortran-4.2-16.el7.x86_64 nspr-4.11.0-1.el7_2.x86_64 nss-3.21.0-9.el7_2.x86_64 nss-softokn-freebl-3.16.2.3-14.2.el7_2.x86_64 nss-util-3.21.0-2.2.el7_2.x86_64 numactl-libs-2.0.9-6.el7_2.x86_64 openldap-2.4.40-9.el7_2.x86_64 openmpi-1.10.0-10.el7.x86_64 opensm-libs-3.3.19-1.el7.x86_64 openssl-libs-1.0.1e-51.el7_2.4.x86_64 pcre-8.32-15.el7.x86_64 xz-libs-5.1.2-12alpha.el7.x86_64 zlib-1.2.7-15.el7.x86_64 > #0 0x0000000000415730 in correct4pressure_ () > #1 0x00000000004aaf28 in MAIN__ () > #2 0x0000000000404327 in main () > Continuing. > [Thread 0x2aaad6cee700 (LWP 171613) exited] > [Thread 0x2aaacbcc1700 (LWP 171612) exited] > [Thread 0x2aaac95e3700 (LWP 171604) exited] > [Thread 0x2aaac93d2700 (LWP 171600) exited] > [Thread 0x2aaaaaae9340 (LWP 171593) exited] > [Inferior 1 (process 171593) exited with code 073] From mvalera-w at sdsu.edu Tue Aug 14 16:23:01 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Tue, 14 Aug 2018 14:23:01 -0700 Subject: [petsc-users] Code break when PETSc not debugging In-Reply-To: <87mutoabxz.fsf@jedbrown.org> References: <87wossafh6.fsf@jedbrown.org> <87mutoabxz.fsf@jedbrown.org> Message-ID: Thanks, i was able to find the bug and correct it, it is working now, I was calling a wrong DM for some DA, Regards, On Tue, Aug 14, 2018 at 2:13 PM, Jed Brown wrote: > Manuel Valera writes: > > > Thanks Jed, > > > > I got the attached, it looks is coming from one of my routines > > CorrectU4Pressure.F90, what other information can i get from this log? > > If you compile with debug info (COPTFLAGS=-g FOPTFLAGS=-g) you'll be > able to see the source line that's causing this error. > > > Thanks, > > > > On Tue, Aug 14, 2018 at 12:57 PM, Jed Brown wrote: > > > >> Manuel Valera writes: > >> > >> > Hello everyone, > >> > > >> > I am working on running part of my code in a GPU, recently i was able > to > >> > run the whole model using one P100 GPU and one processor with good > timing > >> > but using --with-debugging=1 as configure argument, > >> > > >> > With this in mind i compiled PETSc in a separate folder with the same > >> exact > >> > flags except for --with-debugging=no instead to do some profiling, but > >> this > >> > was enough to give segfault as an error after running the code, it > looks > >> > the error happens just after solving the linear system, > >> > > >> > Any idea on why this may be happening? > >> > >> Run in a debugger and send a stack trace. > >> > >> > My configure options: > >> > > >> > ./configure PETSC_ARCH=cuda --with-mpi-dir=/usr/lib64/openmpi > >> > --COPTFLAGS='-O2' --CXXOPTFLAGS='-O2' --FOPTFLAGS='-O2' > >> > --with-shared-libraries=1 --with-debugging=no --with-cuda=1 > >> > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > >> > --download-viennacl > >> > > >> > My running arguments: > >> > > >> > mpirun -n 1 ./gcmLEP tc=TestCases/LockRelease/LE_401x6x101/ > >> jid=cuda_dt0.1 > >> > -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl > >> > -log_view > >> > > >> > Thanks. > >> > > Starting program: /usr/scratch/valera/ParGCCOM/./gcmLEP > tc=TestCases/LockRelease/LE_401x6x101/ jid=cuda_test -dm_vec_type > viennacl -dm_mat_type aijviennacl -ksp_type cg -pc_type saviennacl > > [Thread debugging using libthread_db enabled] > > Using host libthread_db library "/usr/lib64/libthread_db.so.1". > > [New Thread 0x2aaac83b5700 (LWP 171597)] > > [New Thread 0x2aaac93d2700 (LWP 171600)] > > [New Thread 0x2aaac95e3700 (LWP 171604)] > > [New Thread 0x2aaacbcc1700 (LWP 171612)] > > [New Thread 0x2aaad6cee700 (LWP 171613)] > > > > Program received signal SIGSEGV, Segmentation fault. > > 0x0000000000415730 in correct4pressure_ () > > Missing separate debuginfos, use: debuginfo-install > blas-3.4.2-8.el7.x86_64 cyrus-sasl-lib-2.1.26-20.el7_2.x86_64 > glibc-2.17-196.el7_4.2.x86_64 hdf5-1.8.12-7.el7.x86_64 > hwloc-libs-1.7-5.el7.x86_64 infinipath-psm-3.3-0.g6f42cdb1bb8.2.el7.x86_64 > keyutils-libs-1.5.8-3.el7.x86_64 krb5-libs-1.13.2-12.el7_2.x86_64 > lapack-3.4.2-8.el7.x86_64 libX11-1.6.5-1.el7.x86_64 > libXau-1.0.8-2.1.el7.x86_64 libcom_err-1.42.9-7.el7.x86_64 > libcurl-7.29.0-25.el7.centos.x86_64 libcxgb3-1.3.1-8.el7.x86_64 > libcxgb4-1.3.5-3.el7.x86_64 libfabric-1.1.0-2.el7.x86_64 > libgcc-4.8.5-16.el7_4.1.x86_64 libgfortran-4.8.5-16.el7_4.1.x86_64 > libibumad-1.3.10.2-1.el7.x86_64 libibverbs-1.1.8-8.el7.x86_64 > libidn-1.28-4.el7.x86_64 libipathverbs-1.3-2.el7.x86_64 > libjpeg-turbo-1.2.90-5.el7.x86_64 libmlx4-1.0.6-5.el7.x86_64 > libmlx5-1.0.2-1.el7.x86_64 libmthca-1.0.6-13.el7.x86_64 > libnes-1.1.4-2.el7.x86_64 libnl3-3.2.28-4.el7.x86_64 > libpciaccess-0.13.4-2.el7.x86_64 libquadmath-4.8.5-16.el7_4.1.x86_64 > librdmacm-1.0.21-1.el7.x86_64 libselinux-2.2.2-6.el7.x86_64 > libssh2-1.4.3-10.el7_2.1.x86_64 libstdc++-4.8.5-16.el7_4.1.x86_64 > libxcb-1.12-1.el7.x86_64 libxml2-2.9.1-6.el7_2.2.x86_64 > netcdf-4.3.3.1-5.el7.x86_64 netcdf-fortran-4.2-16.el7.x86_64 > nspr-4.11.0-1.el7_2.x86_64 nss-3.21.0-9.el7_2.x86_64 > nss-softokn-freebl-3.16.2.3-14.2.el7_2.x86_64 > nss-util-3.21.0-2.2.el7_2.x86_64 numactl-libs-2.0.9-6.el7_2.x86_64 > openldap-2.4.40-9.el7_2.x86_64 openmpi-1.10.0-10.el7.x86_64 > opensm-libs-3.3.19-1.el7.x86_64 openssl-libs-1.0.1e-51.el7_2.4.x86_64 > pcre-8.32-15.el7.x86_64 xz-libs-5.1.2-12alpha.el7.x86_64 > zlib-1.2.7-15.el7.x86_64 > > #0 0x0000000000415730 in correct4pressure_ () > > #1 0x00000000004aaf28 in MAIN__ () > > #2 0x0000000000404327 in main () > > Continuing. > > [Thread 0x2aaad6cee700 (LWP 171613) exited] > > [Thread 0x2aaacbcc1700 (LWP 171612) exited] > > [Thread 0x2aaac95e3700 (LWP 171604) exited] > > [Thread 0x2aaac93d2700 (LWP 171600) exited] > > [Thread 0x2aaaaaae9340 (LWP 171593) exited] > > [Inferior 1 (process 171593) exited with code 073] > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mvalera-w at sdsu.edu Wed Aug 15 15:39:23 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 15 Aug 2018 13:39:23 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types Message-ID: Hello PETSc devs, I am running into an error when trying to use the MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in one processor. The error happens when calling MatSetValues for this specific configuration. It does not occur when using MPI DMMatrix types only. Any help will be appreciated, Thanks, My program call: mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view The error (repeats after each MatSetValues call): [1]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [1]PETSC ERROR: Argument out of range [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) into matrix [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 13:10:44 2018 [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c [1]PETSC ERROR: #2 MatSetValues() line 1339 in /home/valera/petsc/src/mat/interface/matrix.c My Code structure: call DMCreateMatrix(daDummy,A,ierr) > call MatSetFromOptions(A,ierr) > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > if (numprocs > 1) then ! set matrix type parallel > ! Get local size > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > call VecGetLocalSize(Tmpnat,locsize,ierr) > call VecDestroy(Tmpnat,ierr) > ! Set matrix > #ifdef GPU > call MatSetType(A,MATAIJVIENNACL,ierr) > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > print*,'SETTING GPU TYPES' > #else > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > call DMSetMatType(daDummy,VECMPI,ierr) > call MatSetType(A,MATMPIAIJ,ierr)! > #endif > call > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > else ! set matrix type sequential > #ifdef GPU > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > print*,'SETTING GPU TYPES' > #else > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > call DMSetMatType(daDummy,VECSEQ,ierr) > call MatSetType(A,MATSEQAIJ,ierr) > #endif > call MatSetUp(A,ierr) > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > do k=zstart,zend-1 > do j=ystart,yend-1 > do i=xstart,xend-1 > [..] > call > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > [..] -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 15 15:51:39 2018 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 15 Aug 2018 16:51:39 -0400 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: Message-ID: On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera wrote: > Hello PETSc devs, > > I am running into an error when trying to use the MATMPIAIJVIENNACL Matrix > type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in one > processor. The error happens when calling MatSetValues for this specific > configuration. It does not occur when using MPI DMMatrix types only. > The DM properly preallocates the matrix. I am assuming you do not here. Matt > Any help will be appreciated, > > Thanks, > > > > My program call: > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ > jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type > aijviennacl -pc_type saviennacl -log_view > > > The error (repeats after each MatSetValues call): > > [1]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [1]PETSC ERROR: Argument out of range > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) into > matrix > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 15 13:10:44 2018 > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > My Code structure: > > call DMCreateMatrix(daDummy,A,ierr) >> call MatSetFromOptions(A,ierr) >> call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >> if (numprocs > 1) then ! set matrix type parallel >> ! Get local size >> call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >> call VecGetLocalSize(Tmpnat,locsize,ierr) >> call VecDestroy(Tmpnat,ierr) >> ! Set matrix >> #ifdef GPU >> call MatSetType(A,MATAIJVIENNACL,ierr) >> call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> print*,'SETTING GPU TYPES' >> #else >> call DMSetMatType(daDummy,MATMPIAIJ,ierr) >> call DMSetMatType(daDummy,VECMPI,ierr) >> call MatSetType(A,MATMPIAIJ,ierr)! >> #endif >> call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >> else ! set matrix type sequential >> #ifdef GPU >> call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >> call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >> call MatSetType(A,MATSEQAIJVIENNACL,ierr) >> print*,'SETTING GPU TYPES' >> #else >> call DMSetMatType(daDummy,MATSEQAIJ,ierr) >> call DMSetMatType(daDummy,VECSEQ,ierr) >> call MatSetType(A,MATSEQAIJ,ierr) >> #endif >> call MatSetUp(A,ierr) >> call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >> > > >> do k=zstart,zend-1 >> do j=ystart,yend-1 >> do i=xstart,xend-1 >> [..] >> call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> [..] > > > > > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From mvalera-w at sdsu.edu Wed Aug 15 15:53:44 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 15 Aug 2018 13:53:44 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: Message-ID: Thanks Matthew, I try to do that when calling: call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, PETSC_NULL_INTEGER,ierr) But i am not aware on how to do this for the DM if it needs something more specific/different, Thanks, On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley wrote: > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera wrote: > >> Hello PETSc devs, >> >> I am running into an error when trying to use the MATMPIAIJVIENNACL >> Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in >> one processor. The error happens when calling MatSetValues for this >> specific configuration. It does not occur when using MPI DMMatrix types >> only. >> > > The DM properly preallocates the matrix. I am assuming you do not here. > > Matt > > >> Any help will be appreciated, >> >> Thanks, >> >> >> >> My program call: >> >> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >> aijviennacl -pc_type saviennacl -log_view >> >> >> The error (repeats after each MatSetValues call): >> >> [1]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> [1]PETSC ERROR: Argument out of range >> [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) >> into matrix >> [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT >> Date: 2018-05-31 17:31:13 +0300 >> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >> Aug 15 13:10:44 2018 >> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >> [1]PETSC ERROR: #2 MatSetValues() line 1339 in /home/valera/petsc/src/mat/ >> interface/matrix.c >> >> >> My Code structure: >> >> call DMCreateMatrix(daDummy,A,ierr) >>> call MatSetFromOptions(A,ierr) >>> call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >>> if (numprocs > 1) then ! set matrix type parallel >>> ! Get local size >>> call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>> call VecGetLocalSize(Tmpnat,locsize,ierr) >>> call VecDestroy(Tmpnat,ierr) >>> ! Set matrix >>> #ifdef GPU >>> call MatSetType(A,MATAIJVIENNACL,ierr) >>> call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>> print*,'SETTING GPU TYPES' >>> #else >>> call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>> call DMSetMatType(daDummy,VECMPI,ierr) >>> call MatSetType(A,MATMPIAIJ,ierr)! >>> #endif >>> call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>> PETSC_NULL_INTEGER,ierr) >>> else ! set matrix type sequential >>> #ifdef GPU >>> call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>> call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>> call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>> print*,'SETTING GPU TYPES' >>> #else >>> call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>> call DMSetMatType(daDummy,VECSEQ,ierr) >>> call MatSetType(A,MATSEQAIJ,ierr) >>> #endif >>> call MatSetUp(A,ierr) >>> call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>> >> >> >>> do k=zstart,zend-1 >>> do j=ystart,yend-1 >>> do i=xstart,xend-1 >>> [..] >>> call MatSetValues(A,1,row,sumpos, >>> pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>> [..] >> >> >> >> >> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mvalera-w at sdsu.edu Wed Aug 15 16:10:19 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 15 Aug 2018 14:10:19 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: Message-ID: Ok, I removed the MatSetType call and added DMSetMatrixPreallocateOnly before creating the matrix and this worked out the error, but the same situation persist, when i try to run with more than one processor it says: [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: No support for this operation for this object type [0]PETSC ERROR: Currently only handles ViennaCL matrices [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 14:09:31 2018 [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 14:09:31 2018 [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl Thanks, On Wed, Aug 15, 2018 at 1:53 PM, Manuel Valera wrote: > Thanks Matthew, > > I try to do that when calling: > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ > NULL_INTEGER,ierr) > > But i am not aware on how to do this for the DM if it needs something more > specific/different, > > Thanks, > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > wrote: > >> On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera wrote: >> >>> Hello PETSc devs, >>> >>> I am running into an error when trying to use the MATMPIAIJVIENNACL >>> Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in >>> one processor. The error happens when calling MatSetValues for this >>> specific configuration. It does not occur when using MPI DMMatrix types >>> only. >>> >> >> The DM properly preallocates the matrix. I am assuming you do not here. >> >> Matt >> >> >>> Any help will be appreciated, >>> >>> Thanks, >>> >>> >>> >>> My program call: >>> >>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>> aijviennacl -pc_type saviennacl -log_view >>> >>> >>> The error (repeats after each MatSetValues call): >>> >>> [1]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> [1]PETSC ERROR: Argument out of range >>> [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) >>> into matrix >>> [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >>> for trouble shooting. >>> [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT >>> Date: 2018-05-31 17:31:13 +0300 >>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >>> Aug 15 13:10:44 2018 >>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>> --download-viennacl >>> [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >>> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>> [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>> /home/valera/petsc/src/mat/interface/matrix.c >>> >>> >>> My Code structure: >>> >>> call DMCreateMatrix(daDummy,A,ierr) >>>> call MatSetFromOptions(A,ierr) >>>> call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >>>> if (numprocs > 1) then ! set matrix type parallel >>>> ! Get local size >>>> call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>>> call VecGetLocalSize(Tmpnat,locsize,ierr) >>>> call VecDestroy(Tmpnat,ierr) >>>> ! Set matrix >>>> #ifdef GPU >>>> call MatSetType(A,MATAIJVIENNACL,ierr) >>>> call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>> print*,'SETTING GPU TYPES' >>>> #else >>>> call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>> call DMSetMatType(daDummy,VECMPI,ierr) >>>> call MatSetType(A,MATMPIAIJ,ierr)! >>>> #endif >>>> call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >>>> NULL_INTEGER,ierr) >>>> else ! set matrix type sequential >>>> #ifdef GPU >>>> call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>>> call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>>> call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>> print*,'SETTING GPU TYPES' >>>> #else >>>> call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>> call DMSetMatType(daDummy,VECSEQ,ierr) >>>> call MatSetType(A,MATSEQAIJ,ierr) >>>> #endif >>>> call MatSetUp(A,ierr) >>>> call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>> >>> >>> >>>> do k=zstart,zend-1 >>>> do j=ystart,yend-1 >>>> do i=xstart,xend-1 >>>> [..] >>>> call MatSetValues(A,1,row,sumpos,po >>>> s(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>> [..] >>> >>> >>> >>> >>> >>> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 15 16:15:02 2018 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 15 Aug 2018 17:15:02 -0400 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: Message-ID: On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera wrote: > Thanks Matthew, > > I try to do that when calling: > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > But i am not aware on how to do this for the DM if it needs something more > specific/different, > The error says that your preallocation is wrong for the values you are putting in. The DM does not control either, so I do not understand your email. Thanks, Matt > Thanks, > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > wrote: > >> On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera wrote: >> >>> Hello PETSc devs, >>> >>> I am running into an error when trying to use the MATMPIAIJVIENNACL >>> Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in >>> one processor. The error happens when calling MatSetValues for this >>> specific configuration. It does not occur when using MPI DMMatrix types >>> only. >>> >> >> The DM properly preallocates the matrix. I am assuming you do not here. >> >> Matt >> >> >>> Any help will be appreciated, >>> >>> Thanks, >>> >>> >>> >>> My program call: >>> >>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>> aijviennacl -pc_type saviennacl -log_view >>> >>> >>> The error (repeats after each MatSetValues call): >>> >>> [1]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> [1]PETSC ERROR: Argument out of range >>> [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) >>> into matrix >>> [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >>> for trouble shooting. >>> [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT >>> Date: 2018-05-31 17:31:13 +0300 >>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >>> Aug 15 13:10:44 2018 >>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >>> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>> [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>> /home/valera/petsc/src/mat/interface/matrix.c >>> >>> >>> My Code structure: >>> >>> call DMCreateMatrix(daDummy,A,ierr) >>>> call MatSetFromOptions(A,ierr) >>>> call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >>>> if (numprocs > 1) then ! set matrix type parallel >>>> ! Get local size >>>> call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>>> call VecGetLocalSize(Tmpnat,locsize,ierr) >>>> call VecDestroy(Tmpnat,ierr) >>>> ! Set matrix >>>> #ifdef GPU >>>> call MatSetType(A,MATAIJVIENNACL,ierr) >>>> call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>> print*,'SETTING GPU TYPES' >>>> #else >>>> call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>> call DMSetMatType(daDummy,VECMPI,ierr) >>>> call MatSetType(A,MATMPIAIJ,ierr)! >>>> #endif >>>> call >>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>> else ! set matrix type sequential >>>> #ifdef GPU >>>> call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>>> call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>>> call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>> print*,'SETTING GPU TYPES' >>>> #else >>>> call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>> call DMSetMatType(daDummy,VECSEQ,ierr) >>>> call MatSetType(A,MATSEQAIJ,ierr) >>>> #endif >>>> call MatSetUp(A,ierr) >>>> call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>> >>> >>> >>>> do k=zstart,zend-1 >>>> do j=ystart,yend-1 >>>> do i=xstart,xend-1 >>>> [..] >>>> call >>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>> [..] >>> >>> >>> >>> >>> >>> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From mvalera-w at sdsu.edu Wed Aug 15 16:20:26 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 15 Aug 2018 14:20:26 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: Message-ID: It seems to be resumed on: I do not know how to preallocate a DM Matrix correctly. The interesting part is that it only breaks when i need to populate a GPU matrix from MPI, so kudos on that, but it seems i need to do better on my code to get this setup working, Any help would be appreciated, Thanks, On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley wrote: > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera wrote: > >> Thanks Matthew, >> >> I try to do that when calling: >> >> call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> >> But i am not aware on how to do this for the DM if it needs something >> more specific/different, >> > > The error says that your preallocation is wrong for the values you are > putting in. The DM does not control either, > so I do not understand your email. > > Thanks, > > Matt > > >> Thanks, >> >> On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >> wrote: >> >>> On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>> wrote: >>> >>>> Hello PETSc devs, >>>> >>>> I am running into an error when trying to use the MATMPIAIJVIENNACL >>>> Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in >>>> one processor. The error happens when calling MatSetValues for this >>>> specific configuration. It does not occur when using MPI DMMatrix types >>>> only. >>>> >>> >>> The DM properly preallocates the matrix. I am assuming you do not here. >>> >>> Matt >>> >>> >>>> Any help will be appreciated, >>>> >>>> Thanks, >>>> >>>> >>>> >>>> My program call: >>>> >>>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>>> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>> aijviennacl -pc_type saviennacl -log_view >>>> >>>> >>>> The error (repeats after each MatSetValues call): >>>> >>>> [1]PETSC ERROR: --------------------- Error Message >>>> -------------------------------------------------------------- >>>> [1]PETSC ERROR: Argument out of range >>>> [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) >>>> into matrix >>>> [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >>>> for trouble shooting. >>>> [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >>>> GIT Date: 2018-05-31 17:31:13 +0300 >>>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >>>> Aug 15 13:10:44 2018 >>>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>> --download-viennacl >>>> [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >>>> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>>> [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>>> /home/valera/petsc/src/mat/interface/matrix.c >>>> >>>> >>>> My Code structure: >>>> >>>> call DMCreateMatrix(daDummy,A,ierr) >>>>> call MatSetFromOptions(A,ierr) >>>>> call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >>>>> if (numprocs > 1) then ! set matrix type parallel >>>>> ! Get local size >>>>> call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>>>> call VecGetLocalSize(Tmpnat,locsize,ierr) >>>>> call VecDestroy(Tmpnat,ierr) >>>>> ! Set matrix >>>>> #ifdef GPU >>>>> call MatSetType(A,MATAIJVIENNACL,ierr) >>>>> call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>> print*,'SETTING GPU TYPES' >>>>> #else >>>>> call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>>> call DMSetMatType(daDummy,VECMPI,ierr) >>>>> call MatSetType(A,MATMPIAIJ,ierr)! >>>>> #endif >>>>> call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>>>> PETSC_NULL_INTEGER,ierr) >>>>> else ! set matrix type sequential >>>>> #ifdef GPU >>>>> call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>>>> call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>>>> call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>>> print*,'SETTING GPU TYPES' >>>>> #else >>>>> call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>>> call DMSetMatType(daDummy,VECSEQ,ierr) >>>>> call MatSetType(A,MATSEQAIJ,ierr) >>>>> #endif >>>>> call MatSetUp(A,ierr) >>>>> call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>>> >>>> >>>> >>>>> do k=zstart,zend-1 >>>>> do j=ystart,yend-1 >>>>> do i=xstart,xend-1 >>>>> [..] >>>>> call MatSetValues(A,1,row,sumpos, >>>>> pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>> [..] >>>> >>>> >>>> >>>> >>>> >>>> >>> >>> -- >>> 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 >>> >>> https://www.cse.buffalo.edu/~knepley/ >>> >> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 15 16:32:24 2018 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 15 Aug 2018 17:32:24 -0400 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: Message-ID: On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera wrote: > It seems to be resumed on: I do not know how to preallocate a DM Matrix > correctly. > There is only one matrix type, Mat. There are no separate DM matrices. A DM can create a matrix for you using DMCreateMatrix(), but that is a Mat and it is preallocated correctly. I am not sure what you are doing. Thanks, Matt > The interesting part is that it only breaks when i need to populate a GPU > matrix from MPI, so kudos on that, but it seems i need to do better on my > code to get this setup working, > > Any help would be appreciated, > > Thanks, > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > wrote: > >> On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera wrote: >> >>> Thanks Matthew, >>> >>> I try to do that when calling: >>> >>> call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>> PETSC_NULL_INTEGER,ierr) >>> >>> But i am not aware on how to do this for the DM if it needs something >>> more specific/different, >>> >> >> The error says that your preallocation is wrong for the values you are >> putting in. The DM does not control either, >> so I do not understand your email. >> >> Thanks, >> >> Matt >> >> >>> Thanks, >>> >>> On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >>> wrote: >>> >>>> On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>>> wrote: >>>> >>>>> Hello PETSc devs, >>>>> >>>>> I am running into an error when trying to use the MATMPIAIJVIENNACL >>>>> Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in >>>>> one processor. The error happens when calling MatSetValues for this >>>>> specific configuration. It does not occur when using MPI DMMatrix types >>>>> only. >>>>> >>>> >>>> The DM properly preallocates the matrix. I am assuming you do not here. >>>> >>>> Matt >>>> >>>> >>>>> Any help will be appreciated, >>>>> >>>>> Thanks, >>>>> >>>>> >>>>> >>>>> My program call: >>>>> >>>>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>>>> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>> aijviennacl -pc_type saviennacl -log_view >>>>> >>>>> >>>>> The error (repeats after each MatSetValues call): >>>>> >>>>> [1]PETSC ERROR: --------------------- Error Message >>>>> -------------------------------------------------------------- >>>>> [1]PETSC ERROR: Argument out of range >>>>> [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) >>>>> into matrix >>>>> [1]PETSC ERROR: See >>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>> shooting. >>>>> [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >>>>> GIT Date: 2018-05-31 17:31:13 +0300 >>>>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>> Wed Aug 15 13:10:44 2018 >>>>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>> [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >>>>> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>>>> [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>> /home/valera/petsc/src/mat/interface/matrix.c >>>>> >>>>> >>>>> My Code structure: >>>>> >>>>> call DMCreateMatrix(daDummy,A,ierr) >>>>>> call MatSetFromOptions(A,ierr) >>>>>> call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >>>>>> if (numprocs > 1) then ! set matrix type parallel >>>>>> ! Get local size >>>>>> call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>>>>> call VecGetLocalSize(Tmpnat,locsize,ierr) >>>>>> call VecDestroy(Tmpnat,ierr) >>>>>> ! Set matrix >>>>>> #ifdef GPU >>>>>> call MatSetType(A,MATAIJVIENNACL,ierr) >>>>>> call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>> print*,'SETTING GPU TYPES' >>>>>> #else >>>>>> call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>>>> call DMSetMatType(daDummy,VECMPI,ierr) >>>>>> call MatSetType(A,MATMPIAIJ,ierr)! >>>>>> #endif >>>>>> call >>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>> else ! set matrix type sequential >>>>>> #ifdef GPU >>>>>> call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>>>>> call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>>>>> call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>>>> print*,'SETTING GPU TYPES' >>>>>> #else >>>>>> call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>>>> call DMSetMatType(daDummy,VECSEQ,ierr) >>>>>> call MatSetType(A,MATSEQAIJ,ierr) >>>>>> #endif >>>>>> call MatSetUp(A,ierr) >>>>>> call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>>>> >>>>> >>>>> >>>>>> do k=zstart,zend-1 >>>>>> do j=ystart,yend-1 >>>>>> do i=xstart,xend-1 >>>>>> [..] >>>>>> call >>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>> [..] >>>>> >>>>> >>>>> >>>>> >>>>> >>>>> >>>> >>>> -- >>>> 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 >>>> >>>> https://www.cse.buffalo.edu/~knepley/ >>>> >>> >>> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From mvalera-w at sdsu.edu Wed Aug 15 16:45:10 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 15 Aug 2018 14:45:10 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: Message-ID: Ok thanks for clarifying that, i wasn't sure if there were different types, Here is a stripped down version of my code, it seems like the preallocation is working now since the matrix population part is working without problem, but here it is for illustration purposes: call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > call DMCreateMatrix(daDummy,A,ierr) > call MatSetFromOptions(A,ierr) > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > call > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > call MatSetUp(A,ierr) > [...] > call > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > [...] > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) Adding the first line there did the trick, Now the problem seems to be the program is not recognizing the matrix as ViennaCL type when i try with more than one processor, i get now: [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: No support for this operation for this object type [0]PETSC ERROR: Currently only handles ViennaCL matrices [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 14:44:22 2018 [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c When running with: mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view Thanks, On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley wrote: > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera wrote: > >> It seems to be resumed on: I do not know how to preallocate a DM Matrix >> correctly. >> > > There is only one matrix type, Mat. There are no separate DM matrices. A > DM can create a matrix for you > using DMCreateMatrix(), but that is a Mat and it is preallocated > correctly. I am not sure what you are doing. > > Thanks, > > Matt > > >> The interesting part is that it only breaks when i need to populate a GPU >> matrix from MPI, so kudos on that, but it seems i need to do better on my >> code to get this setup working, >> >> Any help would be appreciated, >> >> Thanks, >> >> >> >> On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >> wrote: >> >>> On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >>> wrote: >>> >>>> Thanks Matthew, >>>> >>>> I try to do that when calling: >>>> >>>> call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >>>> NULL_INTEGER,ierr) >>>> >>>> But i am not aware on how to do this for the DM if it needs something >>>> more specific/different, >>>> >>> >>> The error says that your preallocation is wrong for the values you are >>> putting in. The DM does not control either, >>> so I do not understand your email. >>> >>> Thanks, >>> >>> Matt >>> >>> >>>> Thanks, >>>> >>>> On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >>>> wrote: >>>> >>>>> On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>>>> wrote: >>>>> >>>>>> Hello PETSc devs, >>>>>> >>>>>> I am running into an error when trying to use the MATMPIAIJVIENNACL >>>>>> Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in >>>>>> one processor. The error happens when calling MatSetValues for this >>>>>> specific configuration. It does not occur when using MPI DMMatrix types >>>>>> only. >>>>>> >>>>> >>>>> The DM properly preallocates the matrix. I am assuming you do not here. >>>>> >>>>> Matt >>>>> >>>>> >>>>>> Any help will be appreciated, >>>>>> >>>>>> Thanks, >>>>>> >>>>>> >>>>>> >>>>>> My program call: >>>>>> >>>>>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>>>>> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>>> aijviennacl -pc_type saviennacl -log_view >>>>>> >>>>>> >>>>>> The error (repeats after each MatSetValues call): >>>>>> >>>>>> [1]PETSC ERROR: --------------------- Error Message >>>>>> -------------------------------------------------------------- >>>>>> [1]PETSC ERROR: Argument out of range >>>>>> [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) >>>>>> into matrix >>>>>> [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>>>> documentation/faq.html for trouble shooting. >>>>>> [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >>>>>> GIT Date: 2018-05-31 17:31:13 +0300 >>>>>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>> Wed Aug 15 13:10:44 2018 >>>>>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>>>> --download-viennacl >>>>>> [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >>>>>> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>>>>> [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>>> /home/valera/petsc/src/mat/interface/matrix.c >>>>>> >>>>>> >>>>>> My Code structure: >>>>>> >>>>>> call DMCreateMatrix(daDummy,A,ierr) >>>>>>> call MatSetFromOptions(A,ierr) >>>>>>> call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >>>>>>> if (numprocs > 1) then ! set matrix type parallel >>>>>>> ! Get local size >>>>>>> call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>>>>>> call VecGetLocalSize(Tmpnat,locsize,ierr) >>>>>>> call VecDestroy(Tmpnat,ierr) >>>>>>> ! Set matrix >>>>>>> #ifdef GPU >>>>>>> call MatSetType(A,MATAIJVIENNACL,ierr) >>>>>>> call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>>> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>> print*,'SETTING GPU TYPES' >>>>>>> #else >>>>>>> call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>>>>> call DMSetMatType(daDummy,VECMPI,ierr) >>>>>>> call MatSetType(A,MATMPIAIJ,ierr)! >>>>>>> #endif >>>>>>> call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>>>>>> PETSC_NULL_INTEGER,ierr) >>>>>>> else ! set matrix type sequential >>>>>>> #ifdef GPU >>>>>>> call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>>>>>> call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>>>>>> call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>>>>> print*,'SETTING GPU TYPES' >>>>>>> #else >>>>>>> call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>>>>> call DMSetMatType(daDummy,VECSEQ,ierr) >>>>>>> call MatSetType(A,MATSEQAIJ,ierr) >>>>>>> #endif >>>>>>> call MatSetUp(A,ierr) >>>>>>> call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>>>>> >>>>>> >>>>>> >>>>>>> do k=zstart,zend-1 >>>>>>> do j=ystart,yend-1 >>>>>>> do i=xstart,xend-1 >>>>>>> [..] >>>>>>> call MatSetValues(A,1,row,sumpos, >>>>>>> pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>> [..] >>>>>> >>>>>> >>>>>> >>>>>> >>>>>> >>>>>> >>>>> >>>>> -- >>>>> 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 >>>>> >>>>> https://www.cse.buffalo.edu/~knepley/ >>>>> >>>>> >>>> >>>> >>> >>> -- >>> 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 >>> >>> https://www.cse.buffalo.edu/~knepley/ >>> >> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 15 19:30:04 2018 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 15 Aug 2018 20:30:04 -0400 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: Message-ID: On Wed, Aug 15, 2018 at 5:45 PM Manuel Valera wrote: > Ok thanks for clarifying that, i wasn't sure if there were different types, > > Here is a stripped down version of my code, it seems like the > preallocation is working now since the matrix population part is working > without problem, but here it is for illustration purposes: > Good. > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >> call DMCreateMatrix(daDummy,A,ierr) >> call MatSetFromOptions(A,ierr) >> call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > The two statements above should be unnecessary with the command line options you have. > call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >> > This should not be necessary since the matrix you get from DMCreateMatrix() should be preallocated. > call MatSetUp(A,ierr) >> [...] >> call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> [...] >> call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > Adding the first line there did the trick, > > Now the problem seems to be the program is not recognizing the matrix as > ViennaCL type when i try with more than one processor, i get now: > This is a bad error message since it does not tell us the type of the matrix. You could look in the debugger to see what type the matrix is. I would get rid of all the extraneous statements above so we can figure out what is happening. Matt > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Currently only handles ViennaCL matrices > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 15 14:44:22 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: #2 PCSetUp() line 932 in > /home/valera/petsc/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > When running with: > > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ > jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type > aijviennacl -pc_type saviennacl -log_view > > > Thanks, > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > wrote: > >> On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera wrote: >> >>> It seems to be resumed on: I do not know how to preallocate a DM Matrix >>> correctly. >>> >> >> There is only one matrix type, Mat. There are no separate DM matrices. A >> DM can create a matrix for you >> using DMCreateMatrix(), but that is a Mat and it is preallocated >> correctly. I am not sure what you are doing. >> >> Thanks, >> >> Matt >> >> >>> The interesting part is that it only breaks when i need to populate a >>> GPU matrix from MPI, so kudos on that, but it seems i need to do better on >>> my code to get this setup working, >>> >>> Any help would be appreciated, >>> >>> Thanks, >>> >>> >>> >>> On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >>> wrote: >>> >>>> On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >>>> wrote: >>>> >>>>> Thanks Matthew, >>>>> >>>>> I try to do that when calling: >>>>> >>>>> call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>>>> PETSC_NULL_INTEGER,ierr) >>>>> >>>>> But i am not aware on how to do this for the DM if it needs something >>>>> more specific/different, >>>>> >>>> >>>> The error says that your preallocation is wrong for the values you are >>>> putting in. The DM does not control either, >>>> so I do not understand your email. >>>> >>>> Thanks, >>>> >>>> Matt >>>> >>>> >>>>> Thanks, >>>>> >>>>> On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >>>>> wrote: >>>>> >>>>>> On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>>>>> wrote: >>>>>> >>>>>>> Hello PETSc devs, >>>>>>> >>>>>>> I am running into an error when trying to use the MATMPIAIJVIENNACL >>>>>>> Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in >>>>>>> one processor. The error happens when calling MatSetValues for this >>>>>>> specific configuration. It does not occur when using MPI DMMatrix types >>>>>>> only. >>>>>>> >>>>>> >>>>>> The DM properly preallocates the matrix. I am assuming you do not >>>>>> here. >>>>>> >>>>>> Matt >>>>>> >>>>>> >>>>>>> Any help will be appreciated, >>>>>>> >>>>>>> Thanks, >>>>>>> >>>>>>> >>>>>>> >>>>>>> My program call: >>>>>>> >>>>>>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>>>>>> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>>>> aijviennacl -pc_type saviennacl -log_view >>>>>>> >>>>>>> >>>>>>> The error (repeats after each MatSetValues call): >>>>>>> >>>>>>> [1]PETSC ERROR: --------------------- Error Message >>>>>>> -------------------------------------------------------------- >>>>>>> [1]PETSC ERROR: Argument out of range >>>>>>> [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, >>>>>>> 50) into matrix >>>>>>> [1]PETSC ERROR: See >>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>> shooting. >>>>>>> [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >>>>>>> GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>>> Wed Aug 15 13:10:44 2018 >>>>>>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>> [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >>>>>>> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>>>>>> [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>>>> /home/valera/petsc/src/mat/interface/matrix.c >>>>>>> >>>>>>> >>>>>>> My Code structure: >>>>>>> >>>>>>> call DMCreateMatrix(daDummy,A,ierr) >>>>>>>> call MatSetFromOptions(A,ierr) >>>>>>>> call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >>>>>>>> if (numprocs > 1) then ! set matrix type parallel >>>>>>>> ! Get local size >>>>>>>> call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>>>>>>> call VecGetLocalSize(Tmpnat,locsize,ierr) >>>>>>>> call VecDestroy(Tmpnat,ierr) >>>>>>>> ! Set matrix >>>>>>>> #ifdef GPU >>>>>>>> call MatSetType(A,MATAIJVIENNACL,ierr) >>>>>>>> call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>>>> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>>> print*,'SETTING GPU TYPES' >>>>>>>> #else >>>>>>>> call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>>>>>> call DMSetMatType(daDummy,VECMPI,ierr) >>>>>>>> call MatSetType(A,MATMPIAIJ,ierr)! >>>>>>>> #endif >>>>>>>> call >>>>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>>>> else ! set matrix type sequential >>>>>>>> #ifdef GPU >>>>>>>> call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>>>>>>> call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>>>>>>> call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>>>>>> print*,'SETTING GPU TYPES' >>>>>>>> #else >>>>>>>> call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>>>>>> call DMSetMatType(daDummy,VECSEQ,ierr) >>>>>>>> call MatSetType(A,MATSEQAIJ,ierr) >>>>>>>> #endif >>>>>>>> call MatSetUp(A,ierr) >>>>>>>> call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>>>>>> >>>>>>> >>>>>>> >>>>>>>> do k=zstart,zend-1 >>>>>>>> do j=ystart,yend-1 >>>>>>>> do i=xstart,xend-1 >>>>>>>> [..] >>>>>>>> call >>>>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>>> [..] >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>> >>>>>> -- >>>>>> 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 >>>>>> >>>>>> https://www.cse.buffalo.edu/~knepley/ >>>>>> >>>>>> >>>>> >>>>> >>>> >>>> -- >>>> 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 >>>> >>>> https://www.cse.buffalo.edu/~knepley/ >>>> >>> >>> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From boyceg at email.unc.edu Wed Aug 15 19:42:33 2018 From: boyceg at email.unc.edu (Griffith, Boyce Eugene) Date: Thu, 16 Aug 2018 00:42:33 +0000 Subject: [petsc-users] FIELDSPLIT fields Message-ID: Is it permissible to have overlapping fields in FIELDSPLIT? We are specifically thinking about how to handle DOFs living on the interface between two regions. Thanks! ? Boyce From ysjosh.lo at gmail.com Wed Aug 15 19:54:30 2018 From: ysjosh.lo at gmail.com (Josh L) Date: Wed, 15 Aug 2018 19:54:30 -0500 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: Hi Mark, Yes, The vec size is set to 2*total node number. if I run the problem with -ksp_chebyshev_esteig_noisy and -pc_type gamg, I get the same error. If I run the problem with "-ksp_type chebyshev", the problem is not reproduced but it is not converging and I get a NAN residual after 1000s iteration I really appreciate your help. Thanks, Josh 2018-08-14 9:14 GMT-05:00 Mark Adams : > > > On Sun, Aug 12, 2018 at 11:02 PM Smith, Barry F. > wrote: > >> >> Sending this to PETSc users because someone else (Mark?) will know why >> the Eigen estimator fails at iteration 0. >> > > This is failing in the smoothers eigen estimator. I think the RHS is > garbage because you are getting INF/NAN before the iteration starts (0 > iterations and there is no initial guess). FWIW, If you use > -ksp_chebyshev_esteig_noisy, Cheby will generate a random RHS and will get > past the eigen estimator if in fact this is the problem. > > If the code runs without VecSetBlockSize then, all I can think of is, > there is memory corruption ... when you create vec_coord, do you give it a > size m = 2*N ? > > Note, you should be able to reproduce this problem with '-ksp_type > chebyshev' to get GAMG out of the way. > > >> I notice you are using a real old version of PETSc, for GAMG which is >> a fast moving component of PETSc this may fail. You really should work with >> the latest version of PETSc. Why aren't you? >> >> Barry >> >> >> > On Aug 12, 2018, at 9:25 PM, Josh L wrote: >> > >> > Hi Barry, >> > >> > I set the near null space following the example, but I get error when >> solving it with -pc_type gamg(no error if solving with default PC). >> > Moreover, there will be no error if I don't call >> VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space >> will not affect iteration number. >> > >> > Is it because the way I set Dirichlet boundary conditions? >> > I just zero out the corresponding row and modify right hand size. >> > There is no Neumann bc. >> > >> > >> > Thanks, >> > >> > The following is the error I get >> > >> > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > [0]PETSC ERROR: Petsc has generated inconsistent data >> > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at iteration 0 >> > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 >> > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell >> named nid00009 by yslo Sun Aug 12 21:14:17 2018 >> > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 >> --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages >> --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 >> --with-scalar-type=real --with-shared-libraries=1 --with-precision=double >> --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 >> --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack >> --with-spai=1 --download-spai --with-sundials=1 --download-sundials >> --with-hdf5=1 --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 >> --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis >> --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack >> --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles >> --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 >> --download-superlu_dist --with-superlu=1 --download-superlu >> --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis >> --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/16.0.1.150/ >> compilers_and_libraries_2016.1.150/linux/mkl --CFLAGS="-xhost -O2 -g" >> --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" >> > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >> impls/cheby/cheby.c >> > [0]PETSC ERROR: #2 KSPSolve() line 656 in /opt/apps/intel16/cray_mpich_ >> 7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >> > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #7 PCApply_MG() line 343 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #8 PCApply() line 482 in /opt/apps/intel16/cray_mpich_ >> 7_3/petsc/3.7/src/ksp/pc/interface/precon.c >> > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/ >> private/kspimpl.h >> > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itres.c >> > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >> impls/gmres/gmres.c >> > [0]PETSC ERROR: #12 KSPSolve() line 656 in /opt/apps/intel16/cray_mpich_ >> 7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >> > >> > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : >> > >> > >> > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: >> > > >> > > >> > > >> > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : >> > > >> > > >> > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: >> > > > >> > > > Hi Barry, >> > > > >> > > > I use the example ex49 of KSP(linear elasticity problem), and it's >> output of ksp monitor is the same as my reduced problem, so I think my code >> is correct , at least for the reduced problem. >> > > >> > > Are you using -pc_type gamg ? >> > > >> > > No, just with GMRES and default PC. >> > > strangely, with gamg, the final solution is still the same but >> ksp output becomes different between my code and petsc example. >> > > with -pc_type gamg, my code take 35 iteration and petsc example >> takes only 7. >> > >> > You should use GAMG for elasticity type problems. Does you code set >> the near null space like the example does? >> > >> > > >> > > Thanks. >> > > >> > > >> > > > >> > > > Within a Newton's method, several linear system(Ax=b) is solved, >> and b is the residual vector whose norm becomes smaller and smaller. >> > > > Should I change rtol for KSP ? since ||b|| is reducing, and >> converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is >> rarely satisfied ) >> > > > I observe that for the first linear solve in Newton's method, >> iterative solver converges with okay number of iteration >> > > > , but for the following linear solve, iterative solver takes more >> and more iterations. >> > > >> > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 >> > > >> > > Try also -ksp_pc_side right >> > > >> > > >> > > Barry >> > > >> > > >> > > > >> > > > >> > > > Thanks, >> > > > Josh >> > > > >> > > > >> > > > >> > > > >> > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : >> > > > >> > > > Ok, PCGAMG should work well for linear elasticity so on your >> reduced problem use -pc_type gamg then the group (Mark) will have specific >> suggestions for options. We want to see about 20 iterations for >> "well-behaved" linear elasticity problems. >> > > > >> > > > Barry >> > > > >> > > > >> > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: >> > > > > >> > > > > Hi Barry, >> > > > > >> > > > > Thanks for your help. >> > > > > >> > > > > I removed the phase field from my formulation by setting all >> corresponding degrees of freedom as Dirichlet boundary condition, so >> > > > > my formulation becomes simply linear elastic. >> > > > > Then I use CG for KSP and algebraic multigrid for precondiitoner. >> For a 150K dofs problem, the linear solver converges with 200s >> iteration(still too much I think), but with GMRES it again takes 2000 >> iteration to converge. with GMRES and default PC, it barely converges >> within 10K iteration. >> > > > > >> > > > > I will double check my hessian. below is the ksp monitor output >> from GMRES and gamg PC for first 500 iteration. >> > > > > >> > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid >> norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 >> > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid >> norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 >> > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid >> norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 >> > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid >> norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 >> > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid >> norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 >> > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid >> norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 >> > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid >> norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 >> > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid >> norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 >> > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid >> norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 >> > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid >> norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 >> > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid >> norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 >> > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid >> norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 >> > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid >> norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 >> > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid >> norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 >> > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid >> norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 >> > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid >> norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 >> > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid >> norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 >> > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid >> norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 >> > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid >> norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 >> > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid >> norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 >> > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid >> norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 >> > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid >> norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 >> > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid >> norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 >> > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid >> norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 >> > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid >> norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 >> > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid >> norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 >> > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid >> norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 >> > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid >> norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 >> > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid >> norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 >> > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid >> norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 >> > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid >> norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 >> > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid >> norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 >> > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid >> norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 >> > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid >> norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 >> > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid >> norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 >> > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid >> norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 >> > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid >> norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 >> > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid >> norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 >> > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid >> norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 >> > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid >> norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 >> > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid >> norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 >> > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid >> norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 >> > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid >> norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 >> > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid >> norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 >> > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid >> norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 >> > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid >> norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 >> > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid >> norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 >> > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid >> norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 >> > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid >> norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 >> > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid >> norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 >> > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid >> norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 >> > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid >> norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 >> > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid >> norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 >> > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid >> norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 >> > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid >> norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 >> > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid >> norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 >> > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid >> norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 >> > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid >> norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 >> > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid >> norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 >> > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid >> norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 >> > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid >> norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 >> > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid >> norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 >> > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid >> norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 >> > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid >> norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 >> > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid >> norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 >> > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid >> norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 >> > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid >> norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 >> > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid >> norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 >> > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid >> norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 >> > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid >> norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 >> > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid >> norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 >> > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid >> norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 >> > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid >> norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 >> > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid >> norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 >> > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid >> norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 >> > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid >> norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 >> > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid >> norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 >> > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid >> norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 >> > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid >> norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 >> > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid >> norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 >> > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid >> norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 >> > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid >> norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 >> > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid >> norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 >> > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid >> norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 >> > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid >> norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 >> > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid >> norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 >> > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid >> norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 >> > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid >> norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 >> > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid >> norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 >> > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid >> norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 >> > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid >> norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 >> > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid >> norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 >> > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid >> norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 >> > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid >> norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 >> > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid >> norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 >> > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid >> norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 >> > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid >> norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 >> > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid >> norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 >> > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid >> norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 >> > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid >> norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 >> > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid >> norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 >> > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid >> norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 >> > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid >> norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 >> > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid >> norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 >> > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid >> norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 >> > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid >> norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 >> > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid >> norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 >> > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid >> norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 >> > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid >> norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 >> > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid >> norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 >> > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid >> norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 >> > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid >> norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 >> > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid >> norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 >> > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid >> norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 >> > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid >> norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 >> > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid >> norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 >> > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid >> norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 >> > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid >> norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 >> > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid >> norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 >> > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid >> norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 >> > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid >> norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 >> > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid >> norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 >> > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid >> norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 >> > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid >> norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 >> > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid >> norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 >> > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid >> norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 >> > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid >> norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 >> > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid >> norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 >> > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid >> norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 >> > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid >> norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 >> > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid >> norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 >> > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid >> norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 >> > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid >> norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 >> > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid >> norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 >> > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid >> norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 >> > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid >> norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 >> > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid >> norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 >> > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid >> norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 >> > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid >> norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 >> > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid >> norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 >> > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid >> norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 >> > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid >> norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 >> > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid >> norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 >> > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid >> norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 >> > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid >> norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 >> > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid >> norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 >> > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid >> norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 >> > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid >> norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 >> > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid >> norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 >> > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid >> norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 >> > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid >> norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 >> > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid >> norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 >> > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid >> norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 >> > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid >> norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 >> > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid >> norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 >> > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid >> norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 >> > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid >> norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 >> > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid >> norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 >> > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid >> norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 >> > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid >> norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 >> > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid >> norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 >> > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid >> norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 >> > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid >> norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 >> > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid >> norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 >> > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid >> norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 >> > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid >> norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 >> > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid >> norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 >> > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid >> norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 >> > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid >> norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 >> > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid >> norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 >> > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid >> norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 >> > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid >> norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 >> > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid >> norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 >> > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid >> norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 >> > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid >> norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 >> > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid >> norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 >> > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid >> norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 >> > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid >> norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 >> > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid >> norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 >> > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid >> norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 >> > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid >> norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 >> > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid >> norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 >> > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid >> norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 >> > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid >> norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 >> > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid >> norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 >> > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid >> norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 >> > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid >> norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 >> > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid >> norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 >> > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid >> norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 >> > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid >> norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 >> > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid >> norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 >> > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid >> norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 >> > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid >> norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 >> > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid >> norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 >> > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid >> norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 >> > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid >> norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 >> > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid >> norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 >> > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid >> norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 >> > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid >> norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 >> > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid >> norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 >> > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid >> norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 >> > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid >> norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 >> > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid >> norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 >> > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid >> norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 >> > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid >> norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 >> > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid >> norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 >> > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid >> norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 >> > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid >> norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 >> > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid >> norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 >> > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid >> norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 >> > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid >> norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 >> > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid >> norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 >> > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid >> norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 >> > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid >> norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 >> > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid >> norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 >> > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid >> norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 >> > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid >> norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 >> > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid >> norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 >> > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid >> norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 >> > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid >> norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 >> > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid >> norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 >> > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid >> norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 >> > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid >> norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 >> > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid >> norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 >> > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid >> norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 >> > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid >> norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 >> > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid >> norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 >> > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid >> norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 >> > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid >> norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 >> > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid >> norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 >> > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid >> norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 >> > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid >> norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 >> > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid >> norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 >> > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid >> norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 >> > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid >> norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 >> > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid >> norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 >> > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid >> norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 >> > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid >> norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 >> > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid >> norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 >> > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid >> norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 >> > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid >> norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 >> > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid >> norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 >> > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid >> norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 >> > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid >> norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 >> > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid >> norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 >> > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid >> norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 >> > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid >> norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 >> > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid >> norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 >> > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid >> norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 >> > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid >> norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 >> > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid >> norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 >> > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid >> norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 >> > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid >> norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 >> > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid >> norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 >> > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid >> norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 >> > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid >> norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 >> > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid >> norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 >> > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid >> norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 >> > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid >> norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 >> > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid >> norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 >> > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid >> norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 >> > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid >> norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 >> > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid >> norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 >> > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid >> norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 >> > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid >> norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 >> > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid >> norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 >> > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid >> norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 >> > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid >> norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 >> > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid >> norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 >> > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid >> norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 >> > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid >> norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 >> > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid >> norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 >> > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid >> norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 >> > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid >> norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 >> > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid >> norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 >> > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid >> norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 >> > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid >> norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 >> > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid >> norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 >> > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid >> norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 >> > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid >> norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 >> > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid >> norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 >> > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid >> norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 >> > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid >> norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 >> > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid >> norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 >> > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid >> norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 >> > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid >> norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 >> > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid >> norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 >> > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid >> norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 >> > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid >> norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 >> > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid >> norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 >> > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid >> norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 >> > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid >> norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 >> > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid >> norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 >> > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid >> norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 >> > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid >> norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 >> > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid >> norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 >> > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid >> norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 >> > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid >> norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 >> > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid >> norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 >> > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid >> norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 >> > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid >> norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 >> > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid >> norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 >> > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid >> norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 >> > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid >> norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 >> > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid >> norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 >> > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid >> norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 >> > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid >> norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 >> > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid >> norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 >> > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid >> norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 >> > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid >> norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 >> > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid >> norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 >> > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid >> norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 >> > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid >> norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 >> > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid >> norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 >> > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid >> norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 >> > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid >> norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 >> > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid >> norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 >> > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid >> norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 >> > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid >> norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 >> > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid >> norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 >> > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid >> norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 >> > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid >> norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 >> > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid >> norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 >> > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid >> norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 >> > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid >> norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 >> > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid >> norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 >> > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid >> norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 >> > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid >> norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 >> > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid >> norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 >> > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid >> norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 >> > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid >> norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 >> > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid >> norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 >> > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid >> norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 >> > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid >> norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 >> > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid >> norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 >> > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid >> norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 >> > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid >> norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 >> > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid >> norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 >> > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid >> norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 >> > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid >> norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 >> > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid >> norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 >> > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid >> norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 >> > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid >> norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 >> > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid >> norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 >> > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid >> norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 >> > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid >> norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 >> > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid >> norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 >> > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid >> norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 >> > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid >> norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 >> > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid >> norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 >> > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid >> norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 >> > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid >> norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 >> > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid >> norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 >> > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid >> norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 >> > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid >> norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 >> > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid >> norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 >> > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid >> norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 >> > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid >> norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 >> > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid >> norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 >> > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid >> norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 >> > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid >> norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 >> > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid >> norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 >> > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid >> norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 >> > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid >> norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 >> > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid >> norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 >> > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid >> norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 >> > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid >> norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 >> > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid >> norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 >> > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid >> norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 >> > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid >> norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 >> > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid >> norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 >> > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid >> norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 >> > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid >> norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 >> > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid >> norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 >> > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid >> norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 >> > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid >> norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 >> > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid >> norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 >> > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid >> norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 >> > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid >> norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 >> > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid >> norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 >> > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid >> norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 >> > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid >> norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 >> > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid >> norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 >> > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid >> norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 >> > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid >> norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 >> > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid >> norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 >> > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid >> norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 >> > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid >> norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 >> > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid >> norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 >> > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid >> norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 >> > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid >> norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 >> > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid >> norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 >> > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid >> norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 >> > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid >> norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 >> > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid >> norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 >> > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid >> norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 >> > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid >> norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 >> > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid >> norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 >> > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid >> norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 >> > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid >> norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 >> > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid >> norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 >> > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid >> norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 >> > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid >> norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 >> > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid >> norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 >> > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid >> norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 >> > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid >> norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 >> > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid >> norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 >> > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid >> norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 >> > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid >> norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 >> > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid >> norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 >> > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid >> norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 >> > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid >> norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 >> > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid >> norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 >> > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid >> norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 >> > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid >> norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 >> > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid >> norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 >> > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid >> norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 >> > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid >> norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 >> > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid >> norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 >> > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid >> norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 >> > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid >> norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 >> > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid >> norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 >> > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid >> norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 >> > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid >> norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 >> > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid >> norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 >> > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid >> norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 >> > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid >> norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 >> > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid >> norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 >> > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid >> norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 >> > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid >> norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 >> > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid >> norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 >> > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid >> norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 >> > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid >> norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 >> > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid >> norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 >> > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid >> norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 >> > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid >> norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 >> > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid >> norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 >> > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid >> norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 >> > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid >> norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 >> > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid >> norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 >> > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid >> norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 >> > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid >> norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 >> > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid >> norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 >> > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid >> norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 >> > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid >> norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 >> > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid >> norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 >> > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid >> norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 >> > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid >> norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 >> > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid >> norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 >> > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid >> norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 >> > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid >> norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 >> > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid >> norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 >> > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid >> norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 >> > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid >> norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 >> > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid >> norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 >> > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid >> norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 >> > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid >> norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 >> > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid >> norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 >> > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid >> norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 >> > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid >> norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 >> > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid >> norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 >> > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid >> norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 >> > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid >> norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 >> > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid >> norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 >> > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid >> norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 >> > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid >> norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 >> > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid >> norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 >> > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid >> norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 >> > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid >> norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 >> > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid >> norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 >> > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid >> norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 >> > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid >> norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 >> > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid >> norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 >> > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid >> norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 >> > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid >> norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 >> > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid >> norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 >> > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid >> norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 >> > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid >> norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 >> > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid >> norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 >> > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid >> norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 >> > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid >> norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 >> > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid >> norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 >> > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid >> norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 >> > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid >> norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 >> > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid >> norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 >> > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid >> norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 >> > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid >> norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 >> > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid >> norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 >> > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid >> norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 >> > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid >> norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 >> > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid >> norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 >> > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid >> norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 >> > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid >> norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 >> > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid >> norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 >> > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid >> norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 >> > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid >> norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 >> > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid >> norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 >> > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid >> norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 >> > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid >> norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 >> > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid >> norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 >> > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid >> norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : >> > > > > >> > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u >> and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) >> for each field. Then try replacing the direct solvers LU with hypre >> BoomerAMG first one at a time. >> > > > > >> > > > > Let us know how it goes and we'll make additional suggestions, >> > > > > >> > > > > Barry >> > > > > >> > > > > >> > > > > > On Aug 6, 2018, at 12:58 PM, Josh L >> wrote: >> > > > > > >> > > > > > Hi Barry, >> > > > > > >> > > > > > (1) >> > > > > > I am basically solving the equilibrium coupled with phase field >> equation: >> > > > > > >> > > > > > 1-D example >> > > > > > u is displacement and c is phase-field parameter. >> > > > > > >> > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 >> > > > > > >> > > > > > phase-field equation: 2*G_c*L*(\Delta >> c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 >> > > > > > >> > > > > > I solve the above 2 equations coupled. >> > > > > > it is the formulation for quasi-static fracture problem, where >> G_c is the critical energy release rate and L is the length scale in >> phase-field method (both constant). >> > > > > > >> > > > > > The free energy I am using now is >> > > > > > 1-D: >> > > > > > >> > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c >> > > > > > >> > > > > > >> > > > > > it is not convex w.r.t u and c simultaneously. >> > > > > > >> > > > > > (2) >> > > > > > >> > > > > > with an appropriate step size. Newton's method usually >> converges with 5 iteration, and I can see the quadratic convergence of >> Newton's method. >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > Thanks, >> > > > > > Josh >> > > > > > >> > > > > > >> > > > > > >> > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. > >: >> > > > > > >> > > > > > >> > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L >> wrote: >> > > > > > > >> > > > > > > Hi, >> > > > > > > >> > > > > > > I am using GRMES to solve the linear systems within Newton >> Raphson. >> > > > > > > I am using finite element method to solve fracture problem >> with phase field method.(the formulation gives symmetric but indefinite >> hessian so can't use CG) >> > > > > > >> > > > > > What exact equations are you using for the phase field >> method? >> > > > > > >> > > > > > With the direct LU solver roughly how many iterations does >> your Newton's method take? >> > > > > > >> > > > > > >> > > > > > Barry >> > > > > > >> > > > > > > >> > > > > > > The total iteration number to solve one linear system is >> often very large( > 2000) even for a small sized problem(120K degree of >> freedom). I've tried different preconditioner, but it doesn't help a lot. >> I have checked my hessian and right hand side, and sure they are correct. >> > > > > > > >> > > > > > > I think it might stem from the great difference in element >> size(max/min=100) and damage stiffness around crack. >> > > > > > > >> > > > > > > Anyone has idea to reduce the number of iteration? >> > > > > > > >> > > > > > > Now, I get away with it by using LU, which is not ideal for >> large size problem (I will have to run it in the future) >> > > > > > > >> > > > > > > >> > > > > > > Thanks, >> > > > > > > Josh >> > > > > > > >> > > > > > >> > > > > > >> > > > > >> > > > > >> > > > >> > > > >> > >> > >> >> -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 15 20:17:53 2018 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 15 Aug 2018 21:17:53 -0400 Subject: [petsc-users] FIELDSPLIT fields In-Reply-To: References: Message-ID: On Wed, Aug 15, 2018 at 8:42 PM Griffith, Boyce Eugene wrote: > Is it permissible to have overlapping fields in FIELDSPLIT? We are > specifically thinking about how to handle DOFs living on the interface > between two regions. > There is only 1 IS, so no way to do RASM, or any other thing on the overlap. This sort of things was supposed to be handled by GASM. I am not sure that works. If you want blocks that are not parallel, then you can probably use PCPATCH as soon as I get it merged. Matt > Thanks! > > ? Boyce -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From boyceg at email.unc.edu Wed Aug 15 20:58:30 2018 From: boyceg at email.unc.edu (Griffith, Boyce Eugene) Date: Thu, 16 Aug 2018 01:58:30 +0000 Subject: [petsc-users] FIELDSPLIT fields In-Reply-To: References: Message-ID: <0E85D22F-275E-4D80-B257-0007DAE0141A@email.unc.edu> On Aug 15, 2018, at 9:17 PM, Matthew Knepley > wrote: On Wed, Aug 15, 2018 at 8:42 PM Griffith, Boyce Eugene > wrote: Is it permissible to have overlapping fields in FIELDSPLIT? We are specifically thinking about how to handle DOFs living on the interface between two regions. There is only 1 IS, so no way to do RASM, or any other thing on the overlap. This sort of things was supposed to be handled by GASM. There are three big blocks, with one interface between two of them. It may not make much difference which subdomain the interfacial DOFs are assigned to. I am not sure that works. If you want blocks that are not parallel, then you can probably use PCPATCH as soon as I get it merged. Matt Thanks! ? Boyce -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 15 21:02:47 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 16 Aug 2018 02:02:47 +0000 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: Message-ID: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> Should be call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) call DMCreateMatrix(daDummy,A,ierr) and remove the rest. You need to set the type of Mat you want the DM to return BEFORE you create the matrix. Barry > On Aug 15, 2018, at 4:45 PM, Manuel Valera wrote: > > Ok thanks for clarifying that, i wasn't sure if there were different types, > > Here is a stripped down version of my code, it seems like the preallocation is working now since the matrix population part is working without problem, but here it is for illustration purposes: > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > call DMCreateMatrix(daDummy,A,ierr) > call MatSetFromOptions(A,ierr) > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > call MatSetUp(A,ierr) > [...] > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > [...] > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > Adding the first line there did the trick, > > Now the problem seems to be the program is not recognizing the matrix as ViennaCL type when i try with more than one processor, i get now: > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Currently only handles ViennaCL matrices > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 14:44:22 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > When running with: > > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view > > > Thanks, > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley wrote: > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera wrote: > It seems to be resumed on: I do not know how to preallocate a DM Matrix correctly. > > There is only one matrix type, Mat. There are no separate DM matrices. A DM can create a matrix for you > using DMCreateMatrix(), but that is a Mat and it is preallocated correctly. I am not sure what you are doing. > > Thanks, > > Matt > > The interesting part is that it only breaks when i need to populate a GPU matrix from MPI, so kudos on that, but it seems i need to do better on my code to get this setup working, > > Any help would be appreciated, > > Thanks, > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley wrote: > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera wrote: > Thanks Matthew, > > I try to do that when calling: > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > But i am not aware on how to do this for the DM if it needs something more specific/different, > > The error says that your preallocation is wrong for the values you are putting in. The DM does not control either, > so I do not understand your email. > > Thanks, > > Matt > > Thanks, > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley wrote: > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera wrote: > Hello PETSc devs, > > I am running into an error when trying to use the MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in one processor. The error happens when calling MatSetValues for this specific configuration. It does not occur when using MPI DMMatrix types only. > > The DM properly preallocates the matrix. I am assuming you do not here. > > Matt > > Any help will be appreciated, > > Thanks, > > > > My program call: > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view > > > The error (repeats after each MatSetValues call): > > [1]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [1]PETSC ERROR: Argument out of range > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) into matrix > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 13:10:44 2018 > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > [1]PETSC ERROR: #2 MatSetValues() line 1339 in /home/valera/petsc/src/mat/interface/matrix.c > > > My Code structure: > > call DMCreateMatrix(daDummy,A,ierr) > call MatSetFromOptions(A,ierr) > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > if (numprocs > 1) then ! set matrix type parallel > ! Get local size > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > call VecGetLocalSize(Tmpnat,locsize,ierr) > call VecDestroy(Tmpnat,ierr) > ! Set matrix > #ifdef GPU > call MatSetType(A,MATAIJVIENNACL,ierr) > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > print*,'SETTING GPU TYPES' > #else > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > call DMSetMatType(daDummy,VECMPI,ierr) > call MatSetType(A,MATMPIAIJ,ierr)! > #endif > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > else ! set matrix type sequential > #ifdef GPU > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > print*,'SETTING GPU TYPES' > #else > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > call DMSetMatType(daDummy,VECSEQ,ierr) > call MatSetType(A,MATSEQAIJ,ierr) > #endif > call MatSetUp(A,ierr) > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > do k=zstart,zend-1 > do j=ystart,yend-1 > do i=xstart,xend-1 > [..] > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > [..] > > > > > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > From bsmith at mcs.anl.gov Wed Aug 15 21:07:04 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 16 Aug 2018 02:07:04 +0000 Subject: [petsc-users] FIELDSPLIT fields In-Reply-To: References: Message-ID: Yes you can have "overlapping fields" with FIELDSPLIT but I don't think you can use FIELDSPLIT for your case. You seem to have a geometric decomposition into regions. ASM and GASM are intended for such decompositions. Fieldsplit is for multiple fields that each live across the entire domain. Barry > On Aug 15, 2018, at 7:42 PM, Griffith, Boyce Eugene wrote: > > Is it permissible to have overlapping fields in FIELDSPLIT? We are specifically thinking about how to handle DOFs living on the interface between two regions. > > Thanks! > > ? Boyce From boyceg at email.unc.edu Wed Aug 15 21:11:03 2018 From: boyceg at email.unc.edu (Griffith, Boyce Eugene) Date: Thu, 16 Aug 2018 02:11:03 +0000 Subject: [petsc-users] FIELDSPLIT fields In-Reply-To: References: Message-ID: <7B57F78B-1888-411F-B510-F2083367463F@email.unc.edu> > On Aug 15, 2018, at 10:07 PM, Smith, Barry F. wrote: > > > Yes you can have "overlapping fields" with FIELDSPLIT but I don't think you can use FIELDSPLIT for your case. You seem to have a geometric decomposition into regions. ASM and GASM are intended for such decompositions. Fieldsplit is for multiple fields that each live across the entire domain. Basically there is one field the lives on the entire domain, and another field that lives only on a subdomain. Perhaps we could do GASM for the geometric split and FIELDSPLIT within the subdomain with the two fields. > Barry > > >> On Aug 15, 2018, at 7:42 PM, Griffith, Boyce Eugene wrote: >> >> Is it permissible to have overlapping fields in FIELDSPLIT? We are specifically thinking about how to handle DOFs living on the interface between two regions. >> >> Thanks! >> >> ? Boyce > From mvalera-w at sdsu.edu Wed Aug 15 21:44:14 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 15 Aug 2018 19:44:14 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> Message-ID: Thanks Matthew and Barry, Now my code looks like: call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > call DMCreateMatrix(daDummy,A,ierr) > call MatSetFromOptions(A,ierr) call MatSetUp(A,ierr) > [...] > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), > INSERT_VALUES,ierr) > [...] > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) And i get a different error, now is: [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Column too large: col 10980 max 124 [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 19:40:00 2018 [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in /home/valera/petsc/src/mat/impls/aij/seq/aij.c [0]PETSC ERROR: #2 MatSetValues() line 1339 in /home/valera/petsc/src/mat/interface/matrix.c Thanks again, On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. wrote: > > Should be > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > call DMCreateMatrix(daDummy,A,ierr) > > and remove the rest. You need to set the type of Mat you want the DM to > return BEFORE you create the matrix. > > Barry > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera wrote: > > > > Ok thanks for clarifying that, i wasn't sure if there were different > types, > > > > Here is a stripped down version of my code, it seems like the > preallocation is working now since the matrix population part is working > without problem, but here it is for illustration purposes: > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > call DMCreateMatrix(daDummy,A,ierr) > > call MatSetFromOptions(A,ierr) > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > call MatSetUp(A,ierr) > > [...] > > call MatSetValues(A,1,row,sumpos, > pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > [...] > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > Adding the first line there did the trick, > > > > Now the problem seems to be the program is not recognizing the matrix as > ViennaCL type when i try with more than one processor, i get now: > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [0]PETSC ERROR: No support for this operation for this object type > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 15 14:44:22 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ > ksp/interface/itfunc.c > > > > When running with: > > > > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ > jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type > aijviennacl -pc_type saviennacl -log_view > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > wrote: > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > wrote: > > It seems to be resumed on: I do not know how to preallocate a DM Matrix > correctly. > > > > There is only one matrix type, Mat. There are no separate DM matrices. A > DM can create a matrix for you > > using DMCreateMatrix(), but that is a Mat and it is preallocated > correctly. I am not sure what you are doing. > > > > Thanks, > > > > Matt > > > > The interesting part is that it only breaks when i need to populate a > GPU matrix from MPI, so kudos on that, but it seems i need to do better on > my code to get this setup working, > > > > Any help would be appreciated, > > > > Thanks, > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > wrote: > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > wrote: > > Thanks Matthew, > > > > I try to do that when calling: > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > But i am not aware on how to do this for the DM if it needs something > more specific/different, > > > > The error says that your preallocation is wrong for the values you are > putting in. The DM does not control either, > > so I do not understand your email. > > > > Thanks, > > > > Matt > > > > Thanks, > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > wrote: > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > wrote: > > Hello PETSc devs, > > > > I am running into an error when trying to use the MATMPIAIJVIENNACL > Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in > one processor. The error happens when calling MatSetValues for this > specific configuration. It does not occur when using MPI DMMatrix types > only. > > > > The DM properly preallocates the matrix. I am assuming you do not here. > > > > Matt > > > > Any help will be appreciated, > > > > Thanks, > > > > > > > > My program call: > > > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ > jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type > aijviennacl -pc_type saviennacl -log_view > > > > > > The error (repeats after each MatSetValues call): > > > > [1]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [1]PETSC ERROR: Argument out of range > > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) > into matrix > > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 15 13:10:44 2018 > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > My Code structure: > > > > call DMCreateMatrix(daDummy,A,ierr) > > call MatSetFromOptions(A,ierr) > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > if (numprocs > 1) then ! set matrix type parallel > > ! Get local size > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > call VecDestroy(Tmpnat,ierr) > > ! Set matrix > > #ifdef GPU > > call MatSetType(A,MATAIJVIENNACL,ierr) > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > print*,'SETTING GPU TYPES' > > #else > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > call DMSetMatType(daDummy,VECMPI,ierr) > > call MatSetType(A,MATMPIAIJ,ierr)! > > #endif > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > else ! set matrix type sequential > > #ifdef GPU > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > print*,'SETTING GPU TYPES' > > #else > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > call DMSetMatType(daDummy,VECSEQ,ierr) > > call MatSetType(A,MATSEQAIJ,ierr) > > #endif > > call MatSetUp(A,ierr) > > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > do k=zstart,zend-1 > > do j=ystart,yend-1 > > do i=xstart,xend-1 > > [..] > > call MatSetValues(A,1,row,sumpos, > pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > [..] > > > > > > > > > > > > > > -- > > 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 > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > -- > > 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 > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > -- > > 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 > > > > https://www.cse.buffalo.edu/~knepley/ > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From dave.mayhem23 at gmail.com Wed Aug 15 23:09:04 2018 From: dave.mayhem23 at gmail.com (Dave May) Date: Thu, 16 Aug 2018 06:09:04 +0200 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> Message-ID: On Thu, 16 Aug 2018 at 04:44, Manuel Valera wrote: > Thanks Matthew and Barry, > > Now my code looks like: > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > call DMCreateMatrix(daDummy,A,ierr) >> call MatSetFromOptions(A,ierr) > > call MatSetUp(A,ierr) >> [...] >> call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> [...] >> call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > And i get a different error, now is: > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Column too large: col 10980 max 124 > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 15 19:40:00 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > Thanks again, > This error has nothing to do with matrix type being used. The size of the matrix is defined by the particular DM. You should be using DM associated data/APIs to set values in the matrix. It's not obvious how the args here call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INS ERT_VALUES,ier actually relate to the DM. Code snippets aren't helpful in this case to understand the error. I suggest you send a complete example illustrating your actual problem. Thanks, Dave > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > wrote: > >> >> Should be >> >> call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> call DMCreateMatrix(daDummy,A,ierr) >> >> and remove the rest. You need to set the type of Mat you want the DM to >> return BEFORE you create the matrix. >> >> Barry >> >> >> >> > On Aug 15, 2018, at 4:45 PM, Manuel Valera wrote: >> > >> > Ok thanks for clarifying that, i wasn't sure if there were different >> types, >> > >> > Here is a stripped down version of my code, it seems like the >> preallocation is working now since the matrix population part is working >> without problem, but here it is for illustration purposes: >> > >> > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >> > call DMCreateMatrix(daDummy,A,ierr) >> > call MatSetFromOptions(A,ierr) >> > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >> > call MatSetUp(A,ierr) >> > [...] >> > call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> > [...] >> > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > >> > Adding the first line there did the trick, >> > >> > Now the problem seems to be the program is not recognizing the matrix >> as ViennaCL type when i try with more than one processor, i get now: >> > >> > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > [0]PETSC ERROR: No support for this operation for this object type >> > [0]PETSC ERROR: Currently only handles ViennaCL matrices >> > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >> Aug 15 14:44:22 2018 >> > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> > [0]PETSC ERROR: #2 PCSetUp() line 932 in >> /home/valera/petsc/src/ksp/pc/interface/precon.c >> > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >> > >> > When running with: >> > >> > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >> aijviennacl -pc_type saviennacl -log_view >> > >> > >> > Thanks, >> > >> > >> > >> > >> > >> > >> > >> > >> > >> > >> > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley >> wrote: >> > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >> wrote: >> > It seems to be resumed on: I do not know how to preallocate a DM Matrix >> correctly. >> > >> > There is only one matrix type, Mat. There are no separate DM matrices. >> A DM can create a matrix for you >> > using DMCreateMatrix(), but that is a Mat and it is preallocated >> correctly. I am not sure what you are doing. >> > >> > Thanks, >> > >> > Matt >> > >> > The interesting part is that it only breaks when i need to populate a >> GPU matrix from MPI, so kudos on that, but it seems i need to do better on >> my code to get this setup working, >> > >> > Any help would be appreciated, >> > >> > Thanks, >> > >> > >> > >> > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >> wrote: >> > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >> wrote: >> > Thanks Matthew, >> > >> > I try to do that when calling: >> > >> > call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >> > >> > But i am not aware on how to do this for the DM if it needs something >> more specific/different, >> > >> > The error says that your preallocation is wrong for the values you are >> putting in. The DM does not control either, >> > so I do not understand your email. >> > >> > Thanks, >> > >> > Matt >> > >> > Thanks, >> > >> > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >> wrote: >> > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >> wrote: >> > Hello PETSc devs, >> > >> > I am running into an error when trying to use the MATMPIAIJVIENNACL >> Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in >> one processor. The error happens when calling MatSetValues for this >> specific configuration. It does not occur when using MPI DMMatrix types >> only. >> > >> > The DM properly preallocates the matrix. I am assuming you do not here. >> > >> > Matt >> > >> > Any help will be appreciated, >> > >> > Thanks, >> > >> > >> > >> > My program call: >> > >> > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >> aijviennacl -pc_type saviennacl -log_view >> > >> > >> > The error (repeats after each MatSetValues call): >> > >> > [1]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > [1]PETSC ERROR: Argument out of range >> > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) >> into matrix >> > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >> Aug 15 13:10:44 2018 >> > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >> > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >> /home/valera/petsc/src/mat/interface/matrix.c >> > >> > >> > My Code structure: >> > >> > call DMCreateMatrix(daDummy,A,ierr) >> > call MatSetFromOptions(A,ierr) >> > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >> > if (numprocs > 1) then ! set matrix type parallel >> > ! Get local size >> > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >> > call VecGetLocalSize(Tmpnat,locsize,ierr) >> > call VecDestroy(Tmpnat,ierr) >> > ! Set matrix >> > #ifdef GPU >> > call MatSetType(A,MATAIJVIENNACL,ierr) >> > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > print*,'SETTING GPU TYPES' >> > #else >> > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >> > call DMSetMatType(daDummy,VECMPI,ierr) >> > call MatSetType(A,MATMPIAIJ,ierr)! >> > #endif >> > call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >> > else ! set matrix type sequential >> > #ifdef GPU >> > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >> > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >> > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >> > print*,'SETTING GPU TYPES' >> > #else >> > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >> > call DMSetMatType(daDummy,VECSEQ,ierr) >> > call MatSetType(A,MATSEQAIJ,ierr) >> > #endif >> > call MatSetUp(A,ierr) >> > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >> > >> > do k=zstart,zend-1 >> > do j=ystart,yend-1 >> > do i=xstart,xend-1 >> > [..] >> > call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> > [..] >> > >> > >> > >> > >> > >> > >> > -- >> > 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 >> > >> > https://www.cse.buffalo.edu/~knepley/ >> > >> > >> > >> > -- >> > 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 >> > >> > https://www.cse.buffalo.edu/~knepley/ >> > >> > >> > >> > -- >> > 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 >> > >> > https://www.cse.buffalo.edu/~knepley/ >> > >> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From florian.kauer at koalo.de Thu Aug 16 04:07:25 2018 From: florian.kauer at koalo.de (Florian Kauer) Date: Thu, 16 Aug 2018 11:07:25 +0200 Subject: [petsc-users] Max color value exeeds 65535 limit In-Reply-To: <3B60A544-4BD0-4579-9B0F-97736EE0DE9F@anl.gov> References: <5f546463-0465-d7a7-b23f-8e5e5bdf26bd@koalo.de> <3B60A544-4BD0-4579-9B0F-97736EE0DE9F@anl.gov> Message-ID: <5578838f-f744-36f0-1438-43e045bf1584@koalo.de> Thanks! It works very well with SNESComputeJacobianDefault and there is no significant difference in runtime, so obviously the matrix is actually too dense. Greetings, Florian On 14.08.2018 18:09, Smith, Barry F. wrote: > > > Your "sparse" matrix is too dense to realistically use coloring to compute the Jacobian. > > Use instead SNESComputeJacobianDefault > > > > Barry > >> On Aug 14, 2018, at 9:06 AM, Florian Kauer wrote: >> >> Hi, >> I was just testing out if my calculations also work for several 10000 variables and got the following error. Is this a fundamental limit with very large (or complex) systems of equations or does it hint to a bug/wrong configuration in my program? Everything works fine for smaller systems. >> >> [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- >> [0]PETSC ERROR: Argument out of range >> [0]PETSC ERROR: Max color value exeeds 65535 limit. This number is unrealistic. Perhaps a bug in code? >> Current max: 65535 user rewuested: 65536 >> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >> [0]PETSC ERROR: Petsc Release Version 3.8.4, unknown >> [0]PETSC ERROR: ./csma_model on a linux-gnu-c-debug named h3a-srv-crunchie by cto7138 Tue Aug 14 15:59:57 2018 >> [0]PETSC ERROR: Configure options --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --download-mpich --download-fblaslapack >> [0]PETSC ERROR: #1 ISColoringCreate() line 268 in /home/cto7138/petsc/src/vec/is/is/utils/iscoloring.c >> [0]PETSC ERROR: #2 MatColoringPatch_SeqAIJ_Inode() line 2715 in /home/cto7138/petsc/src/mat/impls/aij/seq/inode.c >> [0]PETSC ERROR: #3 MatColoringPatch() line 7566 in /home/cto7138/petsc/src/mat/interface/matrix.c >> [0]PETSC ERROR: #4 MatColoringApply_SL() line 101 in /home/cto7138/petsc/src/mat/color/impls/minpack/color.c >> [0]PETSC ERROR: #5 MatColoringApply() line 360 in /home/cto7138/petsc/src/mat/color/interface/matcoloring.c >> [0]PETSC ERROR: #6 SNESComputeJacobianDefaultColor() line 81 in /home/cto7138/petsc/src/snes/interface/snesj2.c >> [0]PETSC ERROR: #7 SNESComputeJacobian() line 2360 in /home/cto7138/petsc/src/snes/interface/snes.c >> [0]PETSC ERROR: #8 SNESSolve_NEWTONLS() line 222 in /home/cto7138/petsc/src/snes/impls/ls/ls.c >> [0]PETSC ERROR: #9 SNESSolve() line 4131 in /home/cto7138/petsc/src/snes/interface/snes.c >> [0]PETSC ERROR: #10 main() line 401 in /home/cto7138/evaluation/analyticalmultihop/src/csma_model/csma_model.cpp >> [0]PETSC ERROR: PETSc Option Table entries: >> [0]PETSC ERROR: --experiment /home/cto7138/evaluation/results/analytical-csma/inverse-model/21341_95/000/experiment_CSMA.json >> [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- >> >> Greetings, >> Florian > From mfadams at lbl.gov Thu Aug 16 08:40:28 2018 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 16 Aug 2018 09:40:28 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: Does '-ksp_type cg -pc_type jacobi' work? Does '-ksp_type chebyshev -ksp_chebyshev_esteig_noisy and -pc_type jacobi' work? And I may have missed it but are you setting the (6) rigid body mode null space? On Wed, Aug 15, 2018 at 8:54 PM Josh L wrote: > > Hi Mark, > > Yes, The vec size is set to 2*total node number. > > if I run the problem with -ksp_chebyshev_esteig_noisy and -pc_type gamg, > I get the same error. > > If I run the problem with "-ksp_type chebyshev", the problem is not > reproduced but it is not converging and I get a NAN residual after 1000s > iteration > > I really appreciate your help. > > Thanks, > Josh > > 2018-08-14 9:14 GMT-05:00 Mark Adams : > >> >> >> On Sun, Aug 12, 2018 at 11:02 PM Smith, Barry F. >> wrote: >> >>> >>> Sending this to PETSc users because someone else (Mark?) will know why >>> the Eigen estimator fails at iteration 0. >>> >> >> This is failing in the smoothers eigen estimator. I think the RHS is >> garbage because you are getting INF/NAN before the iteration starts (0 >> iterations and there is no initial guess). FWIW, If you use >> -ksp_chebyshev_esteig_noisy, Cheby will generate a random RHS and will get >> past the eigen estimator if in fact this is the problem. >> >> If the code runs without VecSetBlockSize then, all I can think of is, >> there is memory corruption ... when you create vec_coord, do you give it a >> size m = 2*N ? >> >> Note, you should be able to reproduce this problem with '-ksp_type >> chebyshev' to get GAMG out of the way. >> >> >>> I notice you are using a real old version of PETSc, for GAMG which is >>> a fast moving component of PETSc this may fail. You really should work with >>> the latest version of PETSc. Why aren't you? >>> >>> Barry >>> >>> >>> > On Aug 12, 2018, at 9:25 PM, Josh L wrote: >>> > >>> > Hi Barry, >>> > >>> > I set the near null space following the example, but I get error when >>> solving it with -pc_type gamg(no error if solving with default PC). >>> > Moreover, there will be no error if I don't call >>> VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space >>> will not affect iteration number. >>> > >>> > Is it because the way I set Dirichlet boundary conditions? >>> > I just zero out the corresponding row and modify right hand size. >>> > There is no Neumann bc. >>> > >>> > >>> > Thanks, >>> > >>> > The following is the error I get >>> > >>> > [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> > [0]PETSC ERROR: Petsc has generated inconsistent data >>> > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at iteration >>> 0 >>> > [0]PETSC ERROR: See >>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>> shooting. >>> > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 >>> > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell >>> named nid00009 by yslo Sun Aug 12 21:14:17 2018 >>> > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 >>> --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages >>> --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 >>> --with-scalar-type=real --with-shared-libraries=1 --with-precision=double >>> --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 >>> --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack >>> --with-spai=1 --download-spai --with-sundials=1 --download-sundials >>> --with-hdf5=1 >>> --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 >>> --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis >>> --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack >>> --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles >>> --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 >>> --download-superlu_dist --with-superlu=1 --download-superlu >>> --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis >>> --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/ >>> 16.0.1.150/compilers_and_libraries_2016.1.150/linux/mkl >>> --CFLAGS="-xhost -O2 -g" --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" >>> > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/cheby/cheby.c >>> > [0]PETSC ERROR: #2 KSPSolve() line 656 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >>> > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #7 PCApply_MG() line 343 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #8 PCApply() line 482 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/interface/precon.c >>> > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/private/kspimpl.h >>> > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itres.c >>> > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/gmres/gmres.c >>> > [0]PETSC ERROR: #12 KSPSolve() line 656 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >>> > >>> > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : >>> > >>> > >>> > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: >>> > > >>> > > >>> > > >>> > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : >>> > > >>> > > >>> > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: >>> > > > >>> > > > Hi Barry, >>> > > > >>> > > > I use the example ex49 of KSP(linear elasticity problem), and it's >>> output of ksp monitor is the same as my reduced problem, so I think my code >>> is correct , at least for the reduced problem. >>> > > >>> > > Are you using -pc_type gamg ? >>> > > >>> > > No, just with GMRES and default PC. >>> > > strangely, with gamg, the final solution is still the same but >>> ksp output becomes different between my code and petsc example. >>> > > with -pc_type gamg, my code take 35 iteration and petsc >>> example takes only 7. >>> > >>> > You should use GAMG for elasticity type problems. Does you code set >>> the near null space like the example does? >>> > >>> > > >>> > > Thanks. >>> > > >>> > > >>> > > > >>> > > > Within a Newton's method, several linear system(Ax=b) is solved, >>> and b is the residual vector whose norm becomes smaller and smaller. >>> > > > Should I change rtol for KSP ? since ||b|| is reducing, and >>> converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is >>> rarely satisfied ) >>> > > > I observe that for the first linear solve in Newton's method, >>> iterative solver converges with okay number of iteration >>> > > > , but for the following linear solve, iterative solver takes more >>> and more iterations. >>> > > >>> > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 >>> > > >>> > > Try also -ksp_pc_side right >>> > > >>> > > >>> > > Barry >>> > > >>> > > >>> > > > >>> > > > >>> > > > Thanks, >>> > > > Josh >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : >>> > > > >>> > > > Ok, PCGAMG should work well for linear elasticity so on your >>> reduced problem use -pc_type gamg then the group (Mark) will have specific >>> suggestions for options. We want to see about 20 iterations for >>> "well-behaved" linear elasticity problems. >>> > > > >>> > > > Barry >>> > > > >>> > > > >>> > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: >>> > > > > >>> > > > > Hi Barry, >>> > > > > >>> > > > > Thanks for your help. >>> > > > > >>> > > > > I removed the phase field from my formulation by setting all >>> corresponding degrees of freedom as Dirichlet boundary condition, so >>> > > > > my formulation becomes simply linear elastic. >>> > > > > Then I use CG for KSP and algebraic multigrid for >>> precondiitoner. For a 150K dofs problem, the linear solver converges with >>> 200s iteration(still too much I think), but with GMRES it again takes 2000 >>> iteration to converge. with GMRES and default PC, it barely converges >>> within 10K iteration. >>> > > > > >>> > > > > I will double check my hessian. below is the ksp monitor output >>> from GMRES and gamg PC for first 500 iteration. >>> > > > > >>> > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid >>> norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 >>> > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid >>> norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 >>> > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid >>> norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 >>> > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid >>> norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 >>> > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid >>> norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 >>> > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid >>> norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 >>> > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid >>> norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 >>> > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid >>> norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 >>> > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid >>> norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 >>> > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid >>> norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 >>> > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid >>> norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 >>> > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid >>> norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 >>> > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid >>> norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 >>> > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid >>> norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 >>> > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid >>> norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 >>> > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid >>> norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 >>> > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid >>> norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 >>> > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid >>> norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 >>> > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid >>> norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 >>> > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid >>> norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 >>> > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid >>> norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 >>> > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid >>> norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 >>> > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid >>> norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 >>> > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid >>> norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 >>> > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid >>> norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 >>> > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid >>> norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 >>> > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid >>> norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 >>> > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid >>> norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 >>> > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid >>> norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 >>> > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid >>> norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 >>> > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid >>> norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 >>> > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid >>> norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 >>> > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid >>> norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 >>> > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid >>> norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 >>> > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid >>> norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 >>> > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid >>> norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 >>> > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid >>> norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 >>> > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid >>> norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 >>> > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid >>> norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 >>> > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid >>> norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 >>> > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid >>> norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 >>> > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid >>> norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 >>> > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid >>> norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 >>> > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid >>> norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 >>> > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid >>> norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 >>> > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid >>> norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 >>> > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid >>> norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 >>> > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid >>> norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 >>> > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid >>> norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 >>> > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid >>> norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 >>> > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid >>> norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 >>> > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid >>> norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 >>> > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid >>> norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 >>> > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid >>> norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 >>> > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid >>> norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 >>> > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid >>> norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 >>> > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid >>> norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 >>> > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid >>> norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 >>> > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid >>> norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 >>> > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid >>> norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 >>> > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid >>> norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 >>> > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid >>> norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 >>> > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid >>> norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 >>> > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid >>> norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 >>> > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid >>> norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 >>> > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid >>> norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 >>> > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid >>> norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 >>> > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid >>> norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 >>> > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid >>> norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 >>> > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid >>> norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 >>> > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid >>> norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 >>> > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid >>> norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 >>> > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid >>> norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 >>> > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid >>> norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 >>> > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid >>> norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 >>> > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid >>> norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 >>> > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid >>> norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 >>> > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid >>> norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 >>> > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid >>> norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 >>> > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid >>> norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 >>> > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid >>> norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 >>> > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid >>> norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 >>> > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid >>> norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 >>> > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid >>> norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 >>> > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid >>> norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 >>> > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid >>> norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 >>> > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid >>> norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 >>> > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid >>> norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 >>> > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid >>> norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 >>> > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid >>> norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 >>> > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid >>> norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 >>> > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid >>> norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 >>> > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid >>> norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 >>> > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid >>> norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 >>> > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid >>> norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 >>> > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid >>> norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 >>> > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid >>> norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 >>> > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid >>> norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 >>> > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid >>> norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 >>> > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid >>> norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 >>> > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid >>> norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 >>> > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid >>> norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 >>> > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid >>> norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 >>> > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid >>> norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 >>> > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid >>> norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 >>> > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid >>> norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 >>> > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid >>> norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 >>> > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid >>> norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 >>> > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid >>> norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 >>> > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid >>> norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 >>> > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid >>> norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 >>> > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid >>> norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 >>> > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid >>> norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 >>> > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid >>> norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 >>> > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid >>> norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 >>> > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid >>> norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 >>> > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid >>> norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 >>> > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid >>> norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 >>> > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid >>> norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 >>> > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid >>> norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 >>> > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid >>> norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 >>> > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid >>> norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 >>> > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid >>> norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 >>> > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid >>> norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 >>> > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid >>> norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 >>> > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid >>> norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 >>> > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid >>> norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 >>> > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid >>> norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 >>> > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid >>> norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 >>> > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid >>> norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 >>> > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid >>> norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 >>> > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid >>> norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 >>> > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid >>> norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 >>> > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid >>> norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 >>> > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid >>> norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 >>> > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid >>> norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 >>> > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid >>> norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 >>> > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid >>> norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 >>> > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid >>> norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 >>> > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid >>> norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 >>> > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid >>> norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 >>> > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid >>> norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 >>> > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid >>> norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 >>> > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid >>> norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 >>> > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid >>> norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 >>> > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid >>> norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 >>> > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid >>> norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 >>> > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid >>> norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 >>> > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid >>> norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 >>> > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid >>> norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 >>> > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid >>> norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 >>> > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid >>> norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 >>> > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid >>> norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 >>> > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid >>> norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 >>> > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid >>> norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 >>> > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid >>> norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 >>> > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid >>> norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 >>> > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid >>> norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 >>> > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid >>> norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 >>> > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid >>> norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 >>> > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid >>> norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 >>> > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid >>> norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 >>> > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid >>> norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 >>> > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid >>> norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 >>> > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid >>> norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 >>> > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid >>> norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 >>> > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid >>> norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 >>> > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid >>> norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 >>> > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid >>> norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 >>> > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid >>> norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 >>> > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid >>> norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 >>> > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid >>> norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 >>> > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid >>> norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 >>> > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid >>> norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 >>> > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid >>> norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 >>> > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid >>> norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 >>> > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid >>> norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 >>> > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid >>> norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 >>> > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid >>> norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 >>> > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid >>> norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 >>> > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid >>> norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 >>> > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid >>> norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 >>> > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid >>> norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 >>> > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid >>> norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 >>> > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid >>> norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 >>> > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid >>> norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 >>> > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid >>> norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 >>> > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid >>> norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 >>> > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid >>> norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 >>> > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid >>> norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 >>> > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid >>> norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 >>> > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid >>> norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 >>> > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid >>> norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 >>> > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid >>> norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 >>> > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid >>> norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 >>> > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid >>> norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 >>> > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid >>> norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 >>> > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid >>> norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 >>> > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid >>> norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 >>> > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid >>> norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 >>> > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid >>> norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 >>> > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid >>> norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 >>> > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid >>> norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 >>> > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid >>> norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 >>> > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid >>> norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 >>> > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid >>> norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 >>> > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid >>> norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 >>> > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid >>> norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 >>> > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid >>> norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 >>> > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid >>> norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 >>> > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid >>> norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 >>> > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid >>> norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 >>> > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid >>> norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 >>> > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid >>> norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 >>> > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid >>> norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 >>> > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid >>> norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 >>> > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid >>> norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 >>> > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid >>> norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 >>> > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid >>> norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 >>> > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid >>> norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 >>> > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid >>> norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 >>> > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid >>> norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 >>> > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid >>> norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 >>> > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid >>> norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 >>> > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid >>> norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 >>> > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid >>> norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 >>> > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid >>> norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 >>> > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid >>> norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 >>> > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid >>> norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 >>> > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid >>> norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 >>> > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid >>> norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 >>> > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid >>> norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 >>> > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid >>> norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 >>> > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid >>> norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 >>> > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid >>> norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 >>> > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid >>> norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 >>> > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid >>> norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 >>> > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid >>> norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 >>> > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid >>> norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 >>> > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid >>> norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 >>> > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid >>> norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 >>> > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid >>> norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 >>> > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid >>> norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 >>> > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid >>> norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 >>> > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid >>> norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 >>> > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid >>> norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 >>> > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid >>> norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 >>> > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid >>> norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 >>> > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid >>> norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 >>> > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid >>> norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 >>> > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid >>> norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 >>> > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid >>> norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 >>> > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid >>> norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 >>> > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid >>> norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 >>> > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid >>> norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 >>> > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid >>> norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 >>> > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid >>> norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 >>> > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid >>> norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 >>> > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid >>> norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 >>> > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid >>> norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 >>> > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid >>> norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 >>> > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid >>> norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 >>> > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid >>> norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 >>> > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid >>> norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 >>> > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid >>> norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 >>> > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid >>> norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 >>> > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid >>> norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 >>> > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid >>> norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 >>> > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid >>> norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 >>> > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid >>> norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 >>> > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid >>> norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 >>> > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid >>> norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 >>> > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid >>> norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 >>> > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid >>> norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 >>> > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid >>> norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 >>> > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid >>> norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 >>> > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid >>> norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 >>> > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid >>> norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 >>> > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid >>> norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 >>> > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid >>> norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 >>> > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid >>> norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 >>> > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid >>> norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 >>> > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid >>> norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 >>> > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid >>> norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 >>> > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid >>> norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 >>> > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid >>> norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 >>> > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid >>> norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 >>> > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid >>> norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 >>> > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid >>> norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 >>> > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid >>> norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 >>> > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid >>> norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 >>> > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid >>> norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 >>> > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid >>> norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 >>> > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid >>> norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 >>> > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid >>> norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 >>> > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid >>> norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 >>> > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid >>> norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 >>> > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid >>> norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 >>> > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid >>> norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 >>> > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid >>> norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 >>> > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid >>> norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 >>> > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid >>> norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 >>> > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid >>> norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 >>> > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid >>> norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 >>> > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid >>> norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 >>> > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid >>> norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 >>> > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid >>> norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 >>> > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid >>> norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 >>> > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid >>> norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 >>> > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid >>> norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 >>> > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid >>> norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 >>> > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid >>> norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 >>> > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid >>> norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 >>> > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid >>> norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 >>> > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid >>> norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 >>> > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid >>> norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 >>> > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid >>> norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 >>> > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid >>> norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 >>> > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid >>> norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 >>> > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid >>> norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 >>> > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid >>> norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 >>> > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid >>> norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 >>> > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid >>> norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 >>> > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid >>> norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 >>> > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid >>> norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 >>> > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid >>> norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 >>> > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid >>> norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 >>> > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid >>> norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 >>> > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid >>> norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 >>> > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid >>> norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 >>> > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid >>> norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 >>> > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid >>> norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 >>> > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid >>> norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 >>> > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid >>> norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 >>> > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid >>> norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 >>> > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid >>> norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 >>> > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid >>> norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 >>> > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid >>> norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 >>> > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid >>> norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 >>> > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid >>> norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 >>> > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid >>> norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 >>> > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid >>> norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 >>> > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid >>> norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 >>> > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid >>> norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 >>> > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid >>> norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 >>> > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid >>> norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 >>> > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid >>> norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 >>> > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid >>> norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 >>> > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid >>> norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 >>> > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid >>> norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 >>> > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid >>> norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 >>> > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid >>> norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 >>> > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid >>> norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 >>> > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid >>> norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 >>> > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid >>> norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 >>> > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid >>> norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 >>> > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid >>> norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 >>> > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid >>> norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 >>> > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid >>> norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 >>> > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid >>> norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 >>> > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid >>> norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 >>> > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid >>> norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 >>> > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid >>> norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 >>> > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid >>> norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 >>> > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid >>> norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 >>> > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid >>> norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 >>> > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid >>> norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 >>> > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid >>> norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 >>> > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid >>> norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 >>> > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid >>> norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 >>> > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid >>> norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 >>> > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid >>> norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 >>> > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid >>> norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 >>> > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid >>> norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 >>> > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid >>> norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 >>> > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid >>> norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 >>> > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid >>> norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 >>> > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid >>> norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 >>> > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid >>> norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 >>> > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid >>> norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 >>> > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid >>> norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 >>> > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid >>> norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 >>> > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid >>> norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 >>> > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid >>> norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 >>> > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid >>> norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 >>> > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid >>> norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 >>> > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid >>> norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 >>> > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid >>> norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 >>> > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid >>> norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 >>> > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid >>> norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 >>> > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid >>> norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 >>> > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid >>> norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 >>> > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid >>> norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 >>> > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid >>> norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 >>> > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid >>> norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 >>> > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid >>> norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 >>> > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid >>> norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 >>> > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid >>> norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 >>> > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid >>> norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 >>> > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid >>> norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 >>> > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid >>> norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 >>> > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid >>> norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 >>> > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid >>> norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 >>> > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid >>> norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 >>> > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid >>> norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 >>> > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid >>> norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 >>> > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid >>> norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 >>> > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid >>> norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 >>> > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid >>> norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 >>> > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid >>> norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 >>> > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid >>> norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 >>> > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid >>> norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 >>> > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid >>> norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 >>> > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid >>> norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 >>> > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid >>> norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 >>> > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid >>> norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 >>> > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid >>> norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 >>> > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid >>> norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 >>> > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid >>> norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 >>> > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid >>> norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 >>> > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid >>> norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 >>> > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid >>> norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 >>> > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid >>> norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 >>> > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid >>> norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 >>> > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid >>> norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 >>> > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid >>> norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 >>> > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid >>> norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 >>> > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid >>> norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 >>> > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid >>> norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 >>> > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid >>> norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 >>> > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid >>> norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 >>> > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid >>> norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 >>> > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid >>> norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 >>> > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid >>> norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 >>> > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid >>> norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 >>> > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid >>> norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 >>> > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid >>> norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 >>> > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid >>> norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 >>> > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid >>> norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 >>> > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid >>> norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 >>> > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid >>> norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 >>> > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid >>> norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 >>> > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid >>> norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 >>> > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid >>> norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 >>> > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid >>> norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 >>> > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid >>> norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 >>> > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid >>> norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 >>> > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid >>> norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 >>> > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid >>> norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 >>> > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid >>> norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 >>> > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid >>> norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 >>> > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid >>> norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 >>> > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid >>> norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 >>> > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid >>> norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 >>> > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid >>> norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 >>> > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid >>> norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 >>> > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid >>> norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 >>> > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid >>> norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 >>> > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid >>> norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 >>> > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid >>> norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 >>> > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid >>> norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 >>> > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid >>> norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 >>> > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid >>> norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 >>> > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid >>> norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 >>> > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid >>> norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 >>> > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid >>> norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 >>> > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid >>> norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 >>> > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid >>> norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 >>> > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid >>> norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 >>> > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid >>> norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 >>> > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid >>> norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 >>> > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid >>> norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 >>> > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid >>> norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 >>> > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid >>> norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 >>> > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid >>> norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 >>> > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid >>> norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 >>> > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid >>> norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 >>> > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid >>> norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 >>> > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid >>> norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 >>> > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid >>> norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 >>> > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid >>> norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 >>> > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid >>> norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 >>> > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid >>> norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 >>> > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid >>> norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 >>> > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid >>> norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 >>> > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid >>> norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 >>> > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid >>> norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 >>> > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid >>> norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 >>> > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid >>> norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 >>> > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid >>> norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 >>> > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid >>> norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 >>> > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid >>> norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 >>> > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid >>> norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 >>> > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid >>> norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 >>> > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid >>> norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 >>> > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid >>> norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 >>> > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid >>> norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 >>> > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid >>> norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 >>> > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid >>> norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 >>> > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid >>> norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 >>> > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid >>> norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : >>> > > > > >>> > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u >>> and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) >>> for each field. Then try replacing the direct solvers LU with hypre >>> BoomerAMG first one at a time. >>> > > > > >>> > > > > Let us know how it goes and we'll make additional >>> suggestions, >>> > > > > >>> > > > > Barry >>> > > > > >>> > > > > >>> > > > > > On Aug 6, 2018, at 12:58 PM, Josh L >>> wrote: >>> > > > > > >>> > > > > > Hi Barry, >>> > > > > > >>> > > > > > (1) >>> > > > > > I am basically solving the equilibrium coupled with phase >>> field equation: >>> > > > > > >>> > > > > > 1-D example >>> > > > > > u is displacement and c is phase-field parameter. >>> > > > > > >>> > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 >>> > > > > > >>> > > > > > phase-field equation: 2*G_c*L*(\Delta >>> c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 >>> > > > > > >>> > > > > > I solve the above 2 equations coupled. >>> > > > > > it is the formulation for quasi-static fracture problem, where >>> G_c is the critical energy release rate and L is the length scale in >>> phase-field method (both constant). >>> > > > > > >>> > > > > > The free energy I am using now is >>> > > > > > 1-D: >>> > > > > > >>> > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c >>> > > > > > >>> > > > > > >>> > > > > > it is not convex w.r.t u and c simultaneously. >>> > > > > > >>> > > > > > (2) >>> > > > > > >>> > > > > > with an appropriate step size. Newton's method usually >>> converges with 5 iteration, and I can see the quadratic convergence of >>> Newton's method. >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > Thanks, >>> > > > > > Josh >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. >> >: >>> > > > > > >>> > > > > > >>> > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L >>> wrote: >>> > > > > > > >>> > > > > > > Hi, >>> > > > > > > >>> > > > > > > I am using GRMES to solve the linear systems within Newton >>> Raphson. >>> > > > > > > I am using finite element method to solve fracture problem >>> with phase field method.(the formulation gives symmetric but indefinite >>> hessian so can't use CG) >>> > > > > > >>> > > > > > What exact equations are you using for the phase field >>> method? >>> > > > > > >>> > > > > > With the direct LU solver roughly how many iterations >>> does your Newton's method take? >>> > > > > > >>> > > > > > >>> > > > > > Barry >>> > > > > > >>> > > > > > > >>> > > > > > > The total iteration number to solve one linear system is >>> often very large( > 2000) even for a small sized problem(120K degree of >>> freedom). I've tried different preconditioner, but it doesn't help a lot. >>> I have checked my hessian and right hand side, and sure they are correct. >>> > > > > > > >>> > > > > > > I think it might stem from the great difference in element >>> size(max/min=100) and damage stiffness around crack. >>> > > > > > > >>> > > > > > > Anyone has idea to reduce the number of iteration? >>> > > > > > > >>> > > > > > > Now, I get away with it by using LU, which is not ideal for >>> large size problem (I will have to run it in the future) >>> > > > > > > >>> > > > > > > >>> > > > > > > Thanks, >>> > > > > > > Josh >>> > > > > > > >>> > > > > > >>> > > > > > >>> > > > > >>> > > > > >>> > > > >>> > > > >>> > >>> > >>> >>> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Thu Aug 16 08:45:59 2018 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 16 Aug 2018 09:45:59 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: > > > if I run the problem with -ksp_chebyshev_esteig_noisy and -pc_type gamg, > I get the same error. > > And assuming that -ksp_chebyshev_esteig_noisy is working, this implies that the matrix is messed up. It is not clear what level this error happened on. If it is a coarse grid then the jacobi will work. -------------- next part -------------- An HTML attachment was scrubbed... URL: From ysjosh.lo at gmail.com Thu Aug 16 10:21:55 2018 From: ysjosh.lo at gmail.com (Josh L) Date: Thu, 16 Aug 2018 10:21:55 -0500 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: 2018-08-16 8:40 GMT-05:00 Mark Adams : > Does '-ksp_type cg -pc_type jacobi' work? > Yes. and the ksp monitor shows the same output if I ran the same problem with petsc's example. > > Does '-ksp_type chebyshev -ksp_chebyshev_esteig_noisy and -pc_type jacobi' > work? > No. I get a NAN residual after 1000s iteration. > > And I may have missed it but are you setting the (6) rigid body mode null > space? > Yes. with the following code: CALL VecCreate(MPI_COMM_WORLD,vec_coord,ierr) CALL VecSetType(vec_coord,VECSEQ,ierr) CALL VecSetSizes(vec_coord,2*N,2*N,ierr) CALL VecSetBlockSize(vec_coord,2,ierr) get node coordinates in to vec_coord CALL MatNullSpaceCreateRigidBody(vec_coord,matnull,ierr) CALL MatSetNearNullSpace(A,matnull,ierr) Thanks, Josh > > > > On Wed, Aug 15, 2018 at 8:54 PM Josh L wrote: > >> >> Hi Mark, >> >> Yes, The vec size is set to 2*total node number. >> >> if I run the problem with -ksp_chebyshev_esteig_noisy and -pc_type gamg, >> I get the same error. >> >> If I run the problem with "-ksp_type chebyshev", the problem is not >> reproduced but it is not converging and I get a NAN residual after 1000s >> iteration >> >> I really appreciate your help. >> >> Thanks, >> Josh >> >> 2018-08-14 9:14 GMT-05:00 Mark Adams : >> >>> >>> >>> On Sun, Aug 12, 2018 at 11:02 PM Smith, Barry F. >>> wrote: >>> >>>> >>>> Sending this to PETSc users because someone else (Mark?) will know >>>> why the Eigen estimator fails at iteration 0. >>>> >>> >>> This is failing in the smoothers eigen estimator. I think the RHS is >>> garbage because you are getting INF/NAN before the iteration starts (0 >>> iterations and there is no initial guess). FWIW, If you use >>> -ksp_chebyshev_esteig_noisy, Cheby will generate a random RHS and will get >>> past the eigen estimator if in fact this is the problem. >>> >>> If the code runs without VecSetBlockSize then, all I can think of is, >>> there is memory corruption ... when you create vec_coord, do you give it a >>> size m = 2*N ? >>> >>> Note, you should be able to reproduce this problem with '-ksp_type >>> chebyshev' to get GAMG out of the way. >>> >>> >>>> I notice you are using a real old version of PETSc, for GAMG which >>>> is a fast moving component of PETSc this may fail. You really should work >>>> with the latest version of PETSc. Why aren't you? >>>> >>>> Barry >>>> >>>> >>>> > On Aug 12, 2018, at 9:25 PM, Josh L wrote: >>>> > >>>> > Hi Barry, >>>> > >>>> > I set the near null space following the example, but I get error when >>>> solving it with -pc_type gamg(no error if solving with default PC). >>>> > Moreover, there will be no error if I don't call >>>> VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space >>>> will not affect iteration number. >>>> > >>>> > Is it because the way I set Dirichlet boundary conditions? >>>> > I just zero out the corresponding row and modify right hand size. >>>> > There is no Neumann bc. >>>> > >>>> > >>>> > Thanks, >>>> > >>>> > The following is the error I get >>>> > >>>> > [0]PETSC ERROR: --------------------- Error Message >>>> -------------------------------------------------------------- >>>> > [0]PETSC ERROR: Petsc has generated inconsistent data >>>> > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at >>>> iteration 0 >>>> > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>> documentation/faq.html for trouble shooting. >>>> > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 >>>> > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell >>>> named nid00009 by yslo Sun Aug 12 21:14:17 2018 >>>> > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 >>>> --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages >>>> --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 >>>> --with-scalar-type=real --with-shared-libraries=1 --with-precision=double >>>> --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 >>>> --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack >>>> --with-spai=1 --download-spai --with-sundials=1 --download-sundials >>>> --with-hdf5=1 --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 >>>> --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis >>>> --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack >>>> --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles >>>> --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 >>>> --download-superlu_dist --with-superlu=1 --download-superlu >>>> --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis >>>> --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/16.0.1.150/ >>>> compilers_and_libraries_2016.1.150/linux/mkl --CFLAGS="-xhost -O2 -g" >>>> --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" >>>> > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >>>> impls/cheby/cheby.c >>>> > [0]PETSC ERROR: #2 KSPSolve() line 656 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >>>> interface/itfunc.c >>>> > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>>> > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>>> > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>>> > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>>> > [0]PETSC ERROR: #7 PCApply_MG() line 343 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>>> > [0]PETSC ERROR: #8 PCApply() line 482 in /opt/apps/intel16/cray_mpich_ >>>> 7_3/petsc/3.7/src/ksp/pc/interface/precon.c >>>> > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/ >>>> private/kspimpl.h >>>> > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >>>> interface/itres.c >>>> > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >>>> impls/gmres/gmres.c >>>> > [0]PETSC ERROR: #12 KSPSolve() line 656 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >>>> interface/itfunc.c >>>> > >>>> > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : >>>> > >>>> > >>>> > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: >>>> > > >>>> > > >>>> > > >>>> > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : >>>> > > >>>> > > >>>> > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: >>>> > > > >>>> > > > Hi Barry, >>>> > > > >>>> > > > I use the example ex49 of KSP(linear elasticity problem), and >>>> it's output of ksp monitor is the same as my reduced problem, so I think my >>>> code is correct , at least for the reduced problem. >>>> > > >>>> > > Are you using -pc_type gamg ? >>>> > > >>>> > > No, just with GMRES and default PC. >>>> > > strangely, with gamg, the final solution is still the same >>>> but ksp output becomes different between my code and petsc example. >>>> > > with -pc_type gamg, my code take 35 iteration and petsc >>>> example takes only 7. >>>> > >>>> > You should use GAMG for elasticity type problems. Does you code >>>> set the near null space like the example does? >>>> > >>>> > > >>>> > > Thanks. >>>> > > >>>> > > >>>> > > > >>>> > > > Within a Newton's method, several linear system(Ax=b) is solved, >>>> and b is the residual vector whose norm becomes smaller and smaller. >>>> > > > Should I change rtol for KSP ? since ||b|| is reducing, and >>>> converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is >>>> rarely satisfied ) >>>> > > > I observe that for the first linear solve in Newton's method, >>>> iterative solver converges with okay number of iteration >>>> > > > , but for the following linear solve, iterative solver takes more >>>> and more iterations. >>>> > > >>>> > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 >>>> > > >>>> > > Try also -ksp_pc_side right >>>> > > >>>> > > >>>> > > Barry >>>> > > >>>> > > >>>> > > > >>>> > > > >>>> > > > Thanks, >>>> > > > Josh >>>> > > > >>>> > > > >>>> > > > >>>> > > > >>>> > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : >>>> > > > >>>> > > > Ok, PCGAMG should work well for linear elasticity so on your >>>> reduced problem use -pc_type gamg then the group (Mark) will have specific >>>> suggestions for options. We want to see about 20 iterations for >>>> "well-behaved" linear elasticity problems. >>>> > > > >>>> > > > Barry >>>> > > > >>>> > > > >>>> > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: >>>> > > > > >>>> > > > > Hi Barry, >>>> > > > > >>>> > > > > Thanks for your help. >>>> > > > > >>>> > > > > I removed the phase field from my formulation by setting all >>>> corresponding degrees of freedom as Dirichlet boundary condition, so >>>> > > > > my formulation becomes simply linear elastic. >>>> > > > > Then I use CG for KSP and algebraic multigrid for >>>> precondiitoner. For a 150K dofs problem, the linear solver converges with >>>> 200s iteration(still too much I think), but with GMRES it again takes 2000 >>>> iteration to converge. with GMRES and default PC, it barely converges >>>> within 10K iteration. >>>> > > > > >>>> > > > > I will double check my hessian. below is the ksp monitor >>>> output from GMRES and gamg PC for first 500 iteration. >>>> > > > > >>>> > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid >>>> norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 >>>> > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid >>>> norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 >>>> > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid >>>> norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 >>>> > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid >>>> norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 >>>> > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid >>>> norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 >>>> > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid >>>> norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 >>>> > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid >>>> norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 >>>> > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid >>>> norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 >>>> > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid >>>> norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 >>>> > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid >>>> norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 >>>> > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid >>>> norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 >>>> > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid >>>> norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 >>>> > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid >>>> norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 >>>> > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid >>>> norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 >>>> > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid >>>> norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 >>>> > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid >>>> norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 >>>> > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid >>>> norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 >>>> > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid >>>> norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 >>>> > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid >>>> norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 >>>> > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid >>>> norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 >>>> > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid >>>> norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 >>>> > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid >>>> norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 >>>> > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid >>>> norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 >>>> > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid >>>> norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 >>>> > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid >>>> norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 >>>> > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid >>>> norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 >>>> > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid >>>> norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 >>>> > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid >>>> norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 >>>> > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid >>>> norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 >>>> > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid >>>> norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 >>>> > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid >>>> norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 >>>> > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid >>>> norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 >>>> > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid >>>> norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 >>>> > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid >>>> norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 >>>> > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid >>>> norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 >>>> > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid >>>> norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 >>>> > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid >>>> norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 >>>> > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid >>>> norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 >>>> > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid >>>> norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 >>>> > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid >>>> norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 >>>> > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid >>>> norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 >>>> > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid >>>> norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 >>>> > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid >>>> norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 >>>> > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid >>>> norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 >>>> > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid >>>> norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 >>>> > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid >>>> norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 >>>> > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid >>>> norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 >>>> > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid >>>> norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 >>>> > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid >>>> norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 >>>> > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid >>>> norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 >>>> > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid >>>> norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 >>>> > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid >>>> norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 >>>> > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid >>>> norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 >>>> > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid >>>> norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 >>>> > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid >>>> norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 >>>> > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid >>>> norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 >>>> > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid >>>> norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 >>>> > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid >>>> norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 >>>> > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid >>>> norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 >>>> > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid >>>> norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 >>>> > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid >>>> norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 >>>> > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid >>>> norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 >>>> > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid >>>> norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 >>>> > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid >>>> norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 >>>> > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid >>>> norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 >>>> > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid >>>> norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 >>>> > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid >>>> norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 >>>> > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid >>>> norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 >>>> > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid >>>> norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 >>>> > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid >>>> norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 >>>> > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid >>>> norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 >>>> > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid >>>> norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 >>>> > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid >>>> norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 >>>> > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid >>>> norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 >>>> > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid >>>> norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 >>>> > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid >>>> norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 >>>> > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid >>>> norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 >>>> > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid >>>> norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 >>>> > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid >>>> norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 >>>> > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid >>>> norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 >>>> > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid >>>> norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 >>>> > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid >>>> norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 >>>> > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid >>>> norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 >>>> > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid >>>> norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 >>>> > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid >>>> norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 >>>> > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid >>>> norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 >>>> > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid >>>> norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 >>>> > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid >>>> norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 >>>> > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid >>>> norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 >>>> > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid >>>> norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 >>>> > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid >>>> norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 >>>> > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid >>>> norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 >>>> > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid >>>> norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 >>>> > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid >>>> norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 >>>> > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid >>>> norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 >>>> > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid >>>> norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 >>>> > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid >>>> norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 >>>> > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid >>>> norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 >>>> > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid >>>> norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 >>>> > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid >>>> norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 >>>> > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid >>>> norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 >>>> > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid >>>> norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 >>>> > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid >>>> norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 >>>> > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid >>>> norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 >>>> > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid >>>> norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 >>>> > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid >>>> norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 >>>> > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid >>>> norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 >>>> > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid >>>> norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 >>>> > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid >>>> norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 >>>> > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid >>>> norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 >>>> > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid >>>> norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 >>>> > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid >>>> norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 >>>> > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid >>>> norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 >>>> > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid >>>> norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 >>>> > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid >>>> norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 >>>> > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid >>>> norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 >>>> > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid >>>> norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 >>>> > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid >>>> norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 >>>> > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid >>>> norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 >>>> > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid >>>> norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 >>>> > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid >>>> norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 >>>> > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid >>>> norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 >>>> > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid >>>> norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 >>>> > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid >>>> norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 >>>> > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid >>>> norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 >>>> > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid >>>> norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 >>>> > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid >>>> norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 >>>> > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid >>>> norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 >>>> > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid >>>> norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 >>>> > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid >>>> norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 >>>> > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid >>>> norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 >>>> > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid >>>> norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 >>>> > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid >>>> norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 >>>> > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid >>>> norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 >>>> > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid >>>> norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 >>>> > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid >>>> norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 >>>> > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid >>>> norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 >>>> > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid >>>> norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 >>>> > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid >>>> norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 >>>> > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid >>>> norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 >>>> > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid >>>> norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 >>>> > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid >>>> norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 >>>> > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid >>>> norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 >>>> > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid >>>> norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 >>>> > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid >>>> norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 >>>> > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid >>>> norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 >>>> > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid >>>> norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 >>>> > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid >>>> norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 >>>> > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid >>>> norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 >>>> > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid >>>> norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 >>>> > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid >>>> norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 >>>> > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid >>>> norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 >>>> > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid >>>> norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 >>>> > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid >>>> norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 >>>> > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid >>>> norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 >>>> > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid >>>> norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 >>>> > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid >>>> norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 >>>> > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid >>>> norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 >>>> > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid >>>> norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 >>>> > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid >>>> norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 >>>> > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid >>>> norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 >>>> > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid >>>> norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 >>>> > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid >>>> norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 >>>> > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid >>>> norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 >>>> > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid >>>> norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 >>>> > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid >>>> norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 >>>> > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid >>>> norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 >>>> > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid >>>> norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 >>>> > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid >>>> norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 >>>> > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid >>>> norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 >>>> > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid >>>> norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 >>>> > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid >>>> norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 >>>> > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid >>>> norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 >>>> > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid >>>> norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 >>>> > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid >>>> norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 >>>> > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid >>>> norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 >>>> > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid >>>> norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 >>>> > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid >>>> norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 >>>> > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid >>>> norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 >>>> > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid >>>> norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 >>>> > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid >>>> norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 >>>> > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid >>>> norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 >>>> > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid >>>> norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 >>>> > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid >>>> norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 >>>> > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid >>>> norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 >>>> > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid >>>> norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 >>>> > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid >>>> norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 >>>> > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid >>>> norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 >>>> > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid >>>> norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 >>>> > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid >>>> norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 >>>> > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid >>>> norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 >>>> > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid >>>> norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 >>>> > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid >>>> norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 >>>> > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid >>>> norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 >>>> > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid >>>> norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 >>>> > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid >>>> norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 >>>> > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid >>>> norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 >>>> > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid >>>> norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 >>>> > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid >>>> norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 >>>> > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid >>>> norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 >>>> > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid >>>> norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 >>>> > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid >>>> norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 >>>> > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid >>>> norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 >>>> > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid >>>> norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 >>>> > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid >>>> norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 >>>> > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid >>>> norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 >>>> > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid >>>> norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 >>>> > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid >>>> norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 >>>> > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid >>>> norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 >>>> > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid >>>> norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 >>>> > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid >>>> norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 >>>> > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid >>>> norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 >>>> > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid >>>> norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 >>>> > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid >>>> norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 >>>> > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid >>>> norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 >>>> > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid >>>> norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 >>>> > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid >>>> norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 >>>> > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid >>>> norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 >>>> > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid >>>> norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 >>>> > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid >>>> norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 >>>> > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid >>>> norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 >>>> > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid >>>> norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 >>>> > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid >>>> norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 >>>> > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid >>>> norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 >>>> > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid >>>> norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 >>>> > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid >>>> norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 >>>> > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid >>>> norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 >>>> > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid >>>> norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 >>>> > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid >>>> norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 >>>> > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid >>>> norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 >>>> > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid >>>> norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 >>>> > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid >>>> norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 >>>> > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid >>>> norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 >>>> > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid >>>> norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 >>>> > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid >>>> norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 >>>> > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid >>>> norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 >>>> > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid >>>> norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 >>>> > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid >>>> norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 >>>> > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid >>>> norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 >>>> > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid >>>> norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 >>>> > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid >>>> norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 >>>> > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid >>>> norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 >>>> > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid >>>> norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 >>>> > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid >>>> norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 >>>> > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid >>>> norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 >>>> > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid >>>> norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 >>>> > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid >>>> norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 >>>> > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid >>>> norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 >>>> > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid >>>> norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 >>>> > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid >>>> norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 >>>> > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid >>>> norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 >>>> > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid >>>> norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 >>>> > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid >>>> norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 >>>> > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid >>>> norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 >>>> > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid >>>> norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 >>>> > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid >>>> norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 >>>> > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid >>>> norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 >>>> > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid >>>> norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 >>>> > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid >>>> norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 >>>> > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid >>>> norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 >>>> > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid >>>> norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 >>>> > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid >>>> norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 >>>> > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid >>>> norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 >>>> > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid >>>> norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 >>>> > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid >>>> norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 >>>> > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid >>>> norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 >>>> > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid >>>> norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 >>>> > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid >>>> norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 >>>> > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid >>>> norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 >>>> > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid >>>> norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 >>>> > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid >>>> norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 >>>> > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid >>>> norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 >>>> > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid >>>> norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 >>>> > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid >>>> norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 >>>> > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid >>>> norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 >>>> > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid >>>> norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 >>>> > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid >>>> norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 >>>> > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid >>>> norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 >>>> > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid >>>> norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 >>>> > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid >>>> norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 >>>> > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid >>>> norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 >>>> > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid >>>> norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 >>>> > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid >>>> norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 >>>> > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid >>>> norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 >>>> > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid >>>> norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 >>>> > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid >>>> norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 >>>> > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid >>>> norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 >>>> > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid >>>> norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 >>>> > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid >>>> norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 >>>> > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid >>>> norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 >>>> > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid >>>> norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 >>>> > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid >>>> norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 >>>> > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid >>>> norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 >>>> > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid >>>> norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 >>>> > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid >>>> norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 >>>> > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid >>>> norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 >>>> > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid >>>> norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 >>>> > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid >>>> norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 >>>> > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid >>>> norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 >>>> > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid >>>> norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 >>>> > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid >>>> norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 >>>> > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid >>>> norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 >>>> > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid >>>> norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 >>>> > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid >>>> norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 >>>> > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid >>>> norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 >>>> > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid >>>> norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 >>>> > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid >>>> norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 >>>> > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid >>>> norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 >>>> > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid >>>> norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 >>>> > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid >>>> norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 >>>> > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid >>>> norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 >>>> > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid >>>> norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 >>>> > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid >>>> norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 >>>> > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid >>>> norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 >>>> > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid >>>> norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 >>>> > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid >>>> norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 >>>> > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid >>>> norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 >>>> > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid >>>> norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 >>>> > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid >>>> norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 >>>> > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid >>>> norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 >>>> > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid >>>> norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 >>>> > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid >>>> norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 >>>> > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid >>>> norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 >>>> > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid >>>> norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 >>>> > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid >>>> norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 >>>> > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid >>>> norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 >>>> > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid >>>> norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 >>>> > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid >>>> norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 >>>> > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid >>>> norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 >>>> > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid >>>> norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 >>>> > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid >>>> norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 >>>> > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid >>>> norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 >>>> > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid >>>> norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 >>>> > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid >>>> norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 >>>> > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid >>>> norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 >>>> > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid >>>> norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 >>>> > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid >>>> norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 >>>> > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid >>>> norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 >>>> > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid >>>> norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 >>>> > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid >>>> norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 >>>> > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid >>>> norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 >>>> > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid >>>> norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 >>>> > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid >>>> norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 >>>> > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid >>>> norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 >>>> > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid >>>> norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 >>>> > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid >>>> norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 >>>> > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid >>>> norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 >>>> > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid >>>> norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 >>>> > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid >>>> norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 >>>> > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid >>>> norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 >>>> > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid >>>> norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 >>>> > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid >>>> norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 >>>> > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid >>>> norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 >>>> > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid >>>> norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 >>>> > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid >>>> norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 >>>> > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid >>>> norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 >>>> > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid >>>> norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 >>>> > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid >>>> norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 >>>> > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid >>>> norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 >>>> > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid >>>> norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 >>>> > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid >>>> norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 >>>> > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid >>>> norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 >>>> > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid >>>> norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 >>>> > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid >>>> norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 >>>> > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid >>>> norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 >>>> > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid >>>> norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 >>>> > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid >>>> norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 >>>> > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid >>>> norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 >>>> > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid >>>> norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 >>>> > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid >>>> norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 >>>> > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid >>>> norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 >>>> > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid >>>> norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 >>>> > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid >>>> norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 >>>> > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid >>>> norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 >>>> > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid >>>> norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 >>>> > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid >>>> norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 >>>> > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid >>>> norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 >>>> > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid >>>> norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 >>>> > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid >>>> norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 >>>> > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid >>>> norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 >>>> > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid >>>> norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 >>>> > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid >>>> norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 >>>> > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid >>>> norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 >>>> > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid >>>> norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 >>>> > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid >>>> norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 >>>> > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid >>>> norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 >>>> > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid >>>> norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 >>>> > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid >>>> norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 >>>> > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid >>>> norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 >>>> > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid >>>> norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 >>>> > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid >>>> norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 >>>> > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid >>>> norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 >>>> > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid >>>> norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 >>>> > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid >>>> norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 >>>> > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid >>>> norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 >>>> > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid >>>> norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 >>>> > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid >>>> norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 >>>> > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid >>>> norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 >>>> > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid >>>> norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 >>>> > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid >>>> norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 >>>> > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid >>>> norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 >>>> > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid >>>> norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 >>>> > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid >>>> norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 >>>> > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid >>>> norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 >>>> > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid >>>> norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 >>>> > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid >>>> norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 >>>> > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid >>>> norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 >>>> > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid >>>> norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 >>>> > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid >>>> norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 >>>> > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid >>>> norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 >>>> > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid >>>> norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 >>>> > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid >>>> norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 >>>> > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid >>>> norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 >>>> > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid >>>> norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 >>>> > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid >>>> norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 >>>> > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid >>>> norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 >>>> > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid >>>> norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 >>>> > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid >>>> norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 >>>> > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid >>>> norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 >>>> > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid >>>> norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 >>>> > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid >>>> norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 >>>> > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid >>>> norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 >>>> > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid >>>> norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 >>>> > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid >>>> norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 >>>> > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid >>>> norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 >>>> > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid >>>> norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 >>>> > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid >>>> norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 >>>> > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid >>>> norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 >>>> > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid >>>> norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 >>>> > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid >>>> norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 >>>> > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid >>>> norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 >>>> > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid >>>> norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 >>>> > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid >>>> norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 >>>> > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid >>>> norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 >>>> > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid >>>> norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 >>>> > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid >>>> norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 >>>> > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid >>>> norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 >>>> > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid >>>> norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 >>>> > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid >>>> norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 >>>> > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid >>>> norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 >>>> > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid >>>> norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 >>>> > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid >>>> norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 >>>> > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid >>>> norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 >>>> > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid >>>> norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 >>>> > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid >>>> norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 >>>> > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid >>>> norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 >>>> > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid >>>> norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 >>>> > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid >>>> norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 >>>> > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid >>>> norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 >>>> > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid >>>> norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 >>>> > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid >>>> norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 >>>> > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid >>>> norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 >>>> > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid >>>> norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 >>>> > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid >>>> norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 >>>> > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid >>>> norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 >>>> > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid >>>> norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 >>>> > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid >>>> norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 >>>> > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid >>>> norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 >>>> > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid >>>> norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 >>>> > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid >>>> norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 >>>> > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid >>>> norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 >>>> > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid >>>> norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 >>>> > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid >>>> norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 >>>> > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid >>>> norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 >>>> > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid >>>> norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 >>>> > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid >>>> norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 >>>> > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid >>>> norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 >>>> > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid >>>> norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 >>>> > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid >>>> norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 >>>> > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid >>>> norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 >>>> > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid >>>> norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 >>>> > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid >>>> norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 >>>> > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid >>>> norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 >>>> > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid >>>> norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 >>>> > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid >>>> norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 >>>> > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid >>>> norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 >>>> > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid >>>> norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 >>>> > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid >>>> norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 >>>> > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid >>>> norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 >>>> > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid >>>> norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 >>>> > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid >>>> norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 >>>> > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid >>>> norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 >>>> > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid >>>> norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 >>>> > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid >>>> norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 >>>> > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid >>>> norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 >>>> > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid >>>> norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 >>>> > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid >>>> norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 >>>> > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid >>>> norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 >>>> > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid >>>> norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 >>>> > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid >>>> norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 >>>> > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid >>>> norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 >>>> > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid >>>> norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 >>>> > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid >>>> norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 >>>> > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid >>>> norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 >>>> > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid >>>> norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 >>>> > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid >>>> norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 >>>> > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid >>>> norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 >>>> > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid >>>> norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 >>>> > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid >>>> norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 >>>> > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid >>>> norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 >>>> > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid >>>> norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 >>>> > > > > >>>> > > > > >>>> > > > > >>>> > > > > >>>> > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. >>> >: >>>> > > > > >>>> > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u >>>> and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) >>>> for each field. Then try replacing the direct solvers LU with hypre >>>> BoomerAMG first one at a time. >>>> > > > > >>>> > > > > Let us know how it goes and we'll make additional >>>> suggestions, >>>> > > > > >>>> > > > > Barry >>>> > > > > >>>> > > > > >>>> > > > > > On Aug 6, 2018, at 12:58 PM, Josh L >>>> wrote: >>>> > > > > > >>>> > > > > > Hi Barry, >>>> > > > > > >>>> > > > > > (1) >>>> > > > > > I am basically solving the equilibrium coupled with phase >>>> field equation: >>>> > > > > > >>>> > > > > > 1-D example >>>> > > > > > u is displacement and c is phase-field parameter. >>>> > > > > > >>>> > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 >>>> > > > > > >>>> > > > > > phase-field equation: 2*G_c*L*(\Delta >>>> c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 >>>> > > > > > >>>> > > > > > I solve the above 2 equations coupled. >>>> > > > > > it is the formulation for quasi-static fracture problem, >>>> where G_c is the critical energy release rate and L is the length scale in >>>> phase-field method (both constant). >>>> > > > > > >>>> > > > > > The free energy I am using now is >>>> > > > > > 1-D: >>>> > > > > > >>>> > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad >>>> c >>>> > > > > > >>>> > > > > > >>>> > > > > > it is not convex w.r.t u and c simultaneously. >>>> > > > > > >>>> > > > > > (2) >>>> > > > > > >>>> > > > > > with an appropriate step size. Newton's method usually >>>> converges with 5 iteration, and I can see the quadratic convergence of >>>> Newton's method. >>>> > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > > Thanks, >>>> > > > > > Josh >>>> > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. < >>>> bsmith at mcs.anl.gov>: >>>> > > > > > >>>> > > > > > >>>> > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L >>>> wrote: >>>> > > > > > > >>>> > > > > > > Hi, >>>> > > > > > > >>>> > > > > > > I am using GRMES to solve the linear systems within Newton >>>> Raphson. >>>> > > > > > > I am using finite element method to solve fracture problem >>>> with phase field method.(the formulation gives symmetric but indefinite >>>> hessian so can't use CG) >>>> > > > > > >>>> > > > > > What exact equations are you using for the phase field >>>> method? >>>> > > > > > >>>> > > > > > With the direct LU solver roughly how many iterations >>>> does your Newton's method take? >>>> > > > > > >>>> > > > > > >>>> > > > > > Barry >>>> > > > > > >>>> > > > > > > >>>> > > > > > > The total iteration number to solve one linear system is >>>> often very large( > 2000) even for a small sized problem(120K degree of >>>> freedom). I've tried different preconditioner, but it doesn't help a lot. >>>> I have checked my hessian and right hand side, and sure they are correct. >>>> > > > > > > >>>> > > > > > > I think it might stem from the great difference in element >>>> size(max/min=100) and damage stiffness around crack. >>>> > > > > > > >>>> > > > > > > Anyone has idea to reduce the number of iteration? >>>> > > > > > > >>>> > > > > > > Now, I get away with it by using LU, which is not ideal for >>>> large size problem (I will have to run it in the future) >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > Thanks, >>>> > > > > > > Josh >>>> > > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > >>>> > > > > >>>> > > > >>>> > > > >>>> > >>>> > >>>> >>>> >> -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Thu Aug 16 10:39:25 2018 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 16 Aug 2018 11:39:25 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: * Is your matrix symmetric? * I see you said: "> Then I use CG for KSP and algebraic multigrid for precondiitoner. For a 150K dofs problem, the linear solver converges with 200s iteration(still too much I think)" Is this with fracture? A simple cube elasticity test would be the best place to start. Can we get back to this? > Does '-ksp_type cg -pc_type jacobi' work? >> > > Yes. and the ksp monitor shows the same output if I ran the same > problem with petsc's example. > >> >> Does '-ksp_type chebyshev -ksp_chebyshev_esteig_noisy and -pc_type jacobi' >> work? >> > > No. I get a NAN residual after 1000s iteration. > Well this is strange. I think that "noisy" must give you a lower eigen estimate. If your eigen estimate is too low Cheby is not stable. Does this 1000 iterations diverge or does the Nan come out of nowhere? You can check the eigen estimate with '-ksp_chebyshev_esteig_ksp_view' (I think). This will print out solver info including these eigen estimate. Set '-ksp_chebyshev_esteig_ksp_max_it 10' to get the solve to complete and get the ksp_view printout. You can read this. I have to think that this estimate is lower with "noisy". -------------- next part -------------- An HTML attachment was scrubbed... URL: From ysjosh.lo at gmail.com Thu Aug 16 11:20:48 2018 From: ysjosh.lo at gmail.com (Josh L) Date: Thu, 16 Aug 2018 11:20:48 -0500 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: 2018-08-16 10:39 GMT-05:00 Mark Adams : Hi Mark, The problem I am running is simply 2-D linear elasticity, and I use petsc's ex49 of KSP to do benchmark. I have solved the error by using MatZeroRowsColumns(diagonal =1.0) to apply BC instead of MatZeroRows. (My code is actually using newton's method to solve nonlinear problem(Now, use it to run a linear elasticity problem), and the rhs entries for Dirichlet BC is just zero, so either zerorowscolumns or zerorows gives the same solution). With GMRES and gamg, the 120K degrees of freedoms linear elasticity problem converges in 7 iterations. But with " -ksp_type chebyshev -ksp_chebyshev_esteig_noisy" I still get NAN residual that comes out of nowhere (it is not diverging. all of a sudden NAN shows up) * Is your matrix symmetric? > Yes, If I do matzerorowscolumns > > * I see you said: "> Then I use CG for KSP and algebraic multigrid for > precondiitoner. For a 150K dofs problem, the linear solver converges with > 200s iteration(still too much I think)" > > Is this with fracture? A simple cube elasticity test would be the best > place to start. Can we get back to this? > > > >> Does '-ksp_type cg -pc_type jacobi' work? >>> >> >> Yes. and the ksp monitor shows the same output if I ran the same >> problem with petsc's example. >> >>> >>> Does '-ksp_type chebyshev -ksp_chebyshev_esteig_noisy and -pc_type >>> jacobi' work? >>> >> >> No. I get a NAN residual after 1000s iteration. >> > > Well this is strange. I think that "noisy" must give you a lower eigen > estimate. If your eigen estimate is too low Cheby is not stable. Does this > 1000 iterations diverge or does the Nan come out of nowhere? > > You can check the eigen estimate with '-ksp_chebyshev_esteig_ksp_view' (I > think). This will print out solver info including these eigen estimate. > Set '-ksp_chebyshev_esteig_ksp_max_it 10' to get the solve to complete > and get the ksp_view printout. You can read this. I have to think that this > estimate is lower with "noisy". > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From ysjosh.lo at gmail.com Thu Aug 16 11:32:11 2018 From: ysjosh.lo at gmail.com (Josh L) Date: Thu, 16 Aug 2018 11:32:11 -0500 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: Hi Matt, I have solved the error by using MatZeroRowsColumns instead of MatZeroRows. My code is actually using Newton's method to solve nonlinear problem, and what I do is impose the Dirichlet BC before calculating the matrix and rhs(residual vector), and then set the corresponding entries in rhs to zero and zeros out the rows, so the incremental solution for Dirichlet BC is 0. By doing so, MatzeroRowsCloumns and MatZeroRows will actually give the same solution. Thanks, Josh 2018-08-13 9:13 GMT-05:00 Matthew Knepley : > On Sun, Aug 12, 2018 at 11:02 PM Smith, Barry F. > wrote: > >> >> Sending this to PETSc users because someone else (Mark?) will know why >> the Eigen estimator fails at iteration 0. >> > > Are you sure its the estimator? That should be GMRES, but the error is > coming from Chebyshev. > > You are remembering to put something on the diagonal of the zeroed rows, > right? > > Matt > > >> I notice you are using a real old version of PETSc, for GAMG which is >> a fast moving component of PETSc this may fail. You really should work with >> the latest version of PETSc. Why aren't you? >> >> Barry >> >> >> > On Aug 12, 2018, at 9:25 PM, Josh L wrote: >> > >> > Hi Barry, >> > >> > I set the near null space following the example, but I get error when >> solving it with -pc_type gamg(no error if solving with default PC). >> > Moreover, there will be no error if I don't call >> VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space >> will not affect iteration number. >> > >> > Is it because the way I set Dirichlet boundary conditions? >> > I just zero out the corresponding row and modify right hand size. >> > There is no Neumann bc. >> > >> > >> > Thanks, >> > >> > The following is the error I get >> > >> > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > [0]PETSC ERROR: Petsc has generated inconsistent data >> > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at iteration 0 >> > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 >> > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell >> named nid00009 by yslo Sun Aug 12 21:14:17 2018 >> > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 >> --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages >> --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 >> --with-scalar-type=real --with-shared-libraries=1 --with-precision=double >> --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 >> --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack >> --with-spai=1 --download-spai --with-sundials=1 --download-sundials >> --with-hdf5=1 --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 >> --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis >> --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack >> --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles >> --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 >> --download-superlu_dist --with-superlu=1 --download-superlu >> --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis >> --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/16.0.1.150/ >> compilers_and_libraries_2016.1.150/linux/mkl --CFLAGS="-xhost -O2 -g" >> --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" >> > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >> impls/cheby/cheby.c >> > [0]PETSC ERROR: #2 KSPSolve() line 656 in /opt/apps/intel16/cray_mpich_ >> 7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >> > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #7 PCApply_MG() line 343 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >> > [0]PETSC ERROR: #8 PCApply() line 482 in /opt/apps/intel16/cray_mpich_ >> 7_3/petsc/3.7/src/ksp/pc/interface/precon.c >> > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/ >> private/kspimpl.h >> > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itres.c >> > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in >> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >> impls/gmres/gmres.c >> > [0]PETSC ERROR: #12 KSPSolve() line 656 in /opt/apps/intel16/cray_mpich_ >> 7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >> > >> > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : >> > >> > >> > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: >> > > >> > > >> > > >> > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : >> > > >> > > >> > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: >> > > > >> > > > Hi Barry, >> > > > >> > > > I use the example ex49 of KSP(linear elasticity problem), and it's >> output of ksp monitor is the same as my reduced problem, so I think my code >> is correct , at least for the reduced problem. >> > > >> > > Are you using -pc_type gamg ? >> > > >> > > No, just with GMRES and default PC. >> > > strangely, with gamg, the final solution is still the same but >> ksp output becomes different between my code and petsc example. >> > > with -pc_type gamg, my code take 35 iteration and petsc example >> takes only 7. >> > >> > You should use GAMG for elasticity type problems. Does you code set >> the near null space like the example does? >> > >> > > >> > > Thanks. >> > > >> > > >> > > > >> > > > Within a Newton's method, several linear system(Ax=b) is solved, >> and b is the residual vector whose norm becomes smaller and smaller. >> > > > Should I change rtol for KSP ? since ||b|| is reducing, and >> converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is >> rarely satisfied ) >> > > > I observe that for the first linear solve in Newton's method, >> iterative solver converges with okay number of iteration >> > > > , but for the following linear solve, iterative solver takes more >> and more iterations. >> > > >> > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 >> > > >> > > Try also -ksp_pc_side right >> > > >> > > >> > > Barry >> > > >> > > >> > > > >> > > > >> > > > Thanks, >> > > > Josh >> > > > >> > > > >> > > > >> > > > >> > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : >> > > > >> > > > Ok, PCGAMG should work well for linear elasticity so on your >> reduced problem use -pc_type gamg then the group (Mark) will have specific >> suggestions for options. We want to see about 20 iterations for >> "well-behaved" linear elasticity problems. >> > > > >> > > > Barry >> > > > >> > > > >> > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: >> > > > > >> > > > > Hi Barry, >> > > > > >> > > > > Thanks for your help. >> > > > > >> > > > > I removed the phase field from my formulation by setting all >> corresponding degrees of freedom as Dirichlet boundary condition, so >> > > > > my formulation becomes simply linear elastic. >> > > > > Then I use CG for KSP and algebraic multigrid for precondiitoner. >> For a 150K dofs problem, the linear solver converges with 200s >> iteration(still too much I think), but with GMRES it again takes 2000 >> iteration to converge. with GMRES and default PC, it barely converges >> within 10K iteration. >> > > > > >> > > > > I will double check my hessian. below is the ksp monitor output >> from GMRES and gamg PC for first 500 iteration. >> > > > > >> > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid >> norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 >> > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid >> norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 >> > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid >> norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 >> > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid >> norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 >> > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid >> norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 >> > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid >> norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 >> > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid >> norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 >> > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid >> norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 >> > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid >> norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 >> > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid >> norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 >> > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid >> norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 >> > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid >> norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 >> > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid >> norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 >> > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid >> norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 >> > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid >> norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 >> > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid >> norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 >> > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid >> norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 >> > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid >> norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 >> > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid >> norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 >> > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid >> norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 >> > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid >> norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 >> > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid >> norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 >> > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid >> norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 >> > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid >> norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 >> > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid >> norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 >> > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid >> norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 >> > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid >> norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 >> > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid >> norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 >> > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid >> norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 >> > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid >> norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 >> > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid >> norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 >> > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid >> norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 >> > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid >> norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 >> > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid >> norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 >> > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid >> norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 >> > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid >> norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 >> > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid >> norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 >> > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid >> norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 >> > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid >> norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 >> > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid >> norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 >> > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid >> norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 >> > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid >> norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 >> > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid >> norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 >> > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid >> norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 >> > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid >> norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 >> > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid >> norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 >> > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid >> norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 >> > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid >> norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 >> > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid >> norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 >> > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid >> norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 >> > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid >> norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 >> > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid >> norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 >> > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid >> norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 >> > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid >> norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 >> > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid >> norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 >> > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid >> norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 >> > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid >> norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 >> > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid >> norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 >> > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid >> norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 >> > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid >> norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 >> > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid >> norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 >> > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid >> norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 >> > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid >> norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 >> > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid >> norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 >> > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid >> norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 >> > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid >> norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 >> > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid >> norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 >> > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid >> norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 >> > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid >> norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 >> > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid >> norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 >> > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid >> norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 >> > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid >> norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 >> > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid >> norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 >> > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid >> norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 >> > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid >> norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 >> > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid >> norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 >> > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid >> norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 >> > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid >> norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 >> > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid >> norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 >> > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid >> norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 >> > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid >> norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 >> > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid >> norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 >> > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid >> norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 >> > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid >> norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 >> > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid >> norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 >> > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid >> norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 >> > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid >> norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 >> > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid >> norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 >> > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid >> norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 >> > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid >> norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 >> > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid >> norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 >> > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid >> norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 >> > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid >> norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 >> > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid >> norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 >> > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid >> norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 >> > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid >> norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 >> > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid >> norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 >> > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid >> norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 >> > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid >> norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 >> > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid >> norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 >> > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid >> norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 >> > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid >> norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 >> > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid >> norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 >> > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid >> norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 >> > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid >> norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 >> > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid >> norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 >> > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid >> norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 >> > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid >> norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 >> > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid >> norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 >> > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid >> norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 >> > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid >> norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 >> > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid >> norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 >> > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid >> norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 >> > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid >> norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 >> > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid >> norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 >> > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid >> norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 >> > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid >> norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 >> > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid >> norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 >> > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid >> norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 >> > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid >> norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 >> > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid >> norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 >> > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid >> norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 >> > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid >> norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 >> > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid >> norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 >> > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid >> norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 >> > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid >> norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 >> > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid >> norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 >> > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid >> norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 >> > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid >> norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 >> > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid >> norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 >> > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid >> norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 >> > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid >> norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 >> > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid >> norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 >> > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid >> norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 >> > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid >> norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 >> > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid >> norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 >> > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid >> norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 >> > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid >> norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 >> > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid >> norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 >> > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid >> norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 >> > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid >> norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 >> > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid >> norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 >> > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid >> norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 >> > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid >> norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 >> > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid >> norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 >> > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid >> norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 >> > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid >> norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 >> > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid >> norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 >> > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid >> norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 >> > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid >> norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 >> > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid >> norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 >> > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid >> norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 >> > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid >> norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 >> > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid >> norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 >> > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid >> norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 >> > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid >> norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 >> > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid >> norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 >> > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid >> norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 >> > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid >> norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 >> > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid >> norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 >> > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid >> norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 >> > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid >> norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 >> > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid >> norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 >> > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid >> norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 >> > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid >> norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 >> > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid >> norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 >> > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid >> norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 >> > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid >> norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 >> > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid >> norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 >> > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid >> norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 >> > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid >> norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 >> > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid >> norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 >> > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid >> norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 >> > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid >> norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 >> > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid >> norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 >> > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid >> norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 >> > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid >> norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 >> > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid >> norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 >> > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid >> norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 >> > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid >> norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 >> > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid >> norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 >> > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid >> norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 >> > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid >> norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 >> > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid >> norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 >> > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid >> norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 >> > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid >> norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 >> > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid >> norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 >> > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid >> norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 >> > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid >> norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 >> > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid >> norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 >> > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid >> norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 >> > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid >> norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 >> > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid >> norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 >> > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid >> norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 >> > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid >> norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 >> > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid >> norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 >> > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid >> norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 >> > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid >> norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 >> > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid >> norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 >> > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid >> norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 >> > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid >> norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 >> > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid >> norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 >> > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid >> norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 >> > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid >> norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 >> > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid >> norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 >> > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid >> norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 >> > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid >> norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 >> > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid >> norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 >> > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid >> norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 >> > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid >> norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 >> > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid >> norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 >> > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid >> norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 >> > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid >> norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 >> > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid >> norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 >> > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid >> norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 >> > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid >> norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 >> > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid >> norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 >> > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid >> norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 >> > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid >> norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 >> > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid >> norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 >> > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid >> norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 >> > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid >> norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 >> > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid >> norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 >> > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid >> norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 >> > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid >> norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 >> > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid >> norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 >> > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid >> norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 >> > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid >> norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 >> > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid >> norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 >> > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid >> norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 >> > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid >> norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 >> > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid >> norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 >> > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid >> norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 >> > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid >> norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 >> > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid >> norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 >> > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid >> norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 >> > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid >> norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 >> > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid >> norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 >> > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid >> norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 >> > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid >> norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 >> > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid >> norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 >> > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid >> norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 >> > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid >> norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 >> > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid >> norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 >> > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid >> norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 >> > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid >> norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 >> > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid >> norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 >> > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid >> norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 >> > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid >> norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 >> > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid >> norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 >> > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid >> norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 >> > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid >> norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 >> > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid >> norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 >> > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid >> norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 >> > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid >> norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 >> > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid >> norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 >> > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid >> norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 >> > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid >> norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 >> > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid >> norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 >> > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid >> norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 >> > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid >> norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 >> > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid >> norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 >> > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid >> norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 >> > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid >> norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 >> > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid >> norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 >> > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid >> norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 >> > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid >> norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 >> > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid >> norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 >> > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid >> norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 >> > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid >> norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 >> > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid >> norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 >> > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid >> norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 >> > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid >> norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 >> > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid >> norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 >> > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid >> norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 >> > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid >> norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 >> > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid >> norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 >> > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid >> norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 >> > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid >> norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 >> > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid >> norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 >> > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid >> norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 >> > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid >> norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 >> > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid >> norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 >> > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid >> norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 >> > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid >> norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 >> > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid >> norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 >> > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid >> norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 >> > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid >> norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 >> > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid >> norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 >> > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid >> norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 >> > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid >> norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 >> > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid >> norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 >> > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid >> norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 >> > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid >> norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 >> > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid >> norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 >> > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid >> norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 >> > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid >> norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 >> > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid >> norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 >> > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid >> norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 >> > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid >> norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 >> > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid >> norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 >> > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid >> norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 >> > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid >> norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 >> > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid >> norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 >> > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid >> norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 >> > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid >> norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 >> > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid >> norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 >> > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid >> norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 >> > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid >> norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 >> > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid >> norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 >> > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid >> norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 >> > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid >> norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 >> > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid >> norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 >> > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid >> norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 >> > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid >> norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 >> > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid >> norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 >> > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid >> norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 >> > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid >> norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 >> > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid >> norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 >> > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid >> norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 >> > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid >> norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 >> > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid >> norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 >> > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid >> norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 >> > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid >> norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 >> > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid >> norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 >> > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid >> norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 >> > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid >> norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 >> > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid >> norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 >> > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid >> norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 >> > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid >> norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 >> > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid >> norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 >> > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid >> norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 >> > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid >> norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 >> > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid >> norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 >> > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid >> norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 >> > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid >> norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 >> > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid >> norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 >> > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid >> norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 >> > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid >> norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 >> > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid >> norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 >> > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid >> norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 >> > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid >> norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 >> > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid >> norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 >> > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid >> norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 >> > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid >> norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 >> > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid >> norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 >> > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid >> norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 >> > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid >> norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 >> > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid >> norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 >> > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid >> norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 >> > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid >> norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 >> > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid >> norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 >> > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid >> norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 >> > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid >> norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 >> > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid >> norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 >> > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid >> norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 >> > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid >> norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 >> > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid >> norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 >> > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid >> norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 >> > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid >> norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 >> > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid >> norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 >> > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid >> norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 >> > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid >> norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 >> > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid >> norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 >> > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid >> norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 >> > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid >> norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 >> > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid >> norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 >> > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid >> norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 >> > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid >> norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 >> > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid >> norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 >> > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid >> norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 >> > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid >> norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 >> > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid >> norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 >> > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid >> norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 >> > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid >> norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 >> > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid >> norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 >> > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid >> norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 >> > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid >> norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 >> > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid >> norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 >> > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid >> norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 >> > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid >> norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 >> > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid >> norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 >> > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid >> norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 >> > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid >> norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 >> > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid >> norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 >> > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid >> norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 >> > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid >> norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 >> > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid >> norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 >> > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid >> norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 >> > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid >> norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 >> > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid >> norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 >> > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid >> norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 >> > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid >> norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 >> > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid >> norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 >> > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid >> norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 >> > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid >> norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 >> > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid >> norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 >> > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid >> norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 >> > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid >> norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 >> > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid >> norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 >> > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid >> norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 >> > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid >> norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 >> > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid >> norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 >> > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid >> norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 >> > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid >> norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 >> > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid >> norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 >> > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid >> norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 >> > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid >> norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 >> > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid >> norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 >> > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid >> norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 >> > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid >> norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 >> > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid >> norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 >> > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid >> norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 >> > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid >> norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 >> > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid >> norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 >> > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid >> norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 >> > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid >> norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 >> > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid >> norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 >> > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid >> norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 >> > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid >> norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 >> > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid >> norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 >> > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid >> norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 >> > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid >> norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 >> > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid >> norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 >> > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid >> norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 >> > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid >> norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 >> > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid >> norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 >> > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid >> norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 >> > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid >> norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 >> > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid >> norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 >> > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid >> norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 >> > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid >> norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 >> > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid >> norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 >> > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid >> norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 >> > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid >> norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 >> > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid >> norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 >> > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid >> norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 >> > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid >> norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 >> > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid >> norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 >> > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid >> norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 >> > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid >> norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 >> > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid >> norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 >> > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid >> norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 >> > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid >> norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 >> > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid >> norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 >> > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid >> norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 >> > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid >> norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 >> > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid >> norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 >> > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid >> norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 >> > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid >> norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 >> > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid >> norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 >> > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid >> norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 >> > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid >> norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 >> > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid >> norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 >> > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid >> norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 >> > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid >> norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 >> > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid >> norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 >> > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid >> norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 >> > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid >> norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 >> > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid >> norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 >> > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid >> norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 >> > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid >> norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 >> > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid >> norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 >> > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid >> norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 >> > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid >> norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 >> > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid >> norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 >> > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid >> norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 >> > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid >> norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 >> > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid >> norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 >> > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid >> norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 >> > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid >> norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 >> > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid >> norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 >> > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid >> norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 >> > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid >> norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 >> > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid >> norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 >> > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid >> norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 >> > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid >> norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 >> > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid >> norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 >> > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid >> norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 >> > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid >> norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 >> > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid >> norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 >> > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid >> norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 >> > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid >> norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 >> > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid >> norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 >> > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid >> norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 >> > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid >> norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 >> > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid >> norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 >> > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid >> norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 >> > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid >> norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 >> > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid >> norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 >> > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid >> norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 >> > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid >> norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 >> > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid >> norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 >> > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid >> norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 >> > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid >> norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 >> > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid >> norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 >> > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid >> norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 >> > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid >> norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 >> > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid >> norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 >> > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid >> norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 >> > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid >> norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : >> > > > > >> > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u >> and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) >> for each field. Then try replacing the direct solvers LU with hypre >> BoomerAMG first one at a time. >> > > > > >> > > > > Let us know how it goes and we'll make additional suggestions, >> > > > > >> > > > > Barry >> > > > > >> > > > > >> > > > > > On Aug 6, 2018, at 12:58 PM, Josh L >> wrote: >> > > > > > >> > > > > > Hi Barry, >> > > > > > >> > > > > > (1) >> > > > > > I am basically solving the equilibrium coupled with phase field >> equation: >> > > > > > >> > > > > > 1-D example >> > > > > > u is displacement and c is phase-field parameter. >> > > > > > >> > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 >> > > > > > >> > > > > > phase-field equation: 2*G_c*L*(\Delta >> c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 >> > > > > > >> > > > > > I solve the above 2 equations coupled. >> > > > > > it is the formulation for quasi-static fracture problem, where >> G_c is the critical energy release rate and L is the length scale in >> phase-field method (both constant). >> > > > > > >> > > > > > The free energy I am using now is >> > > > > > 1-D: >> > > > > > >> > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c >> > > > > > >> > > > > > >> > > > > > it is not convex w.r.t u and c simultaneously. >> > > > > > >> > > > > > (2) >> > > > > > >> > > > > > with an appropriate step size. Newton's method usually >> converges with 5 iteration, and I can see the quadratic convergence of >> Newton's method. >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > Thanks, >> > > > > > Josh >> > > > > > >> > > > > > >> > > > > > >> > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. > >: >> > > > > > >> > > > > > >> > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L >> wrote: >> > > > > > > >> > > > > > > Hi, >> > > > > > > >> > > > > > > I am using GRMES to solve the linear systems within Newton >> Raphson. >> > > > > > > I am using finite element method to solve fracture problem >> with phase field method.(the formulation gives symmetric but indefinite >> hessian so can't use CG) >> > > > > > >> > > > > > What exact equations are you using for the phase field >> method? >> > > > > > >> > > > > > With the direct LU solver roughly how many iterations does >> your Newton's method take? >> > > > > > >> > > > > > >> > > > > > Barry >> > > > > > >> > > > > > > >> > > > > > > The total iteration number to solve one linear system is >> often very large( > 2000) even for a small sized problem(120K degree of >> freedom). I've tried different preconditioner, but it doesn't help a lot. >> I have checked my hessian and right hand side, and sure they are correct. >> > > > > > > >> > > > > > > I think it might stem from the great difference in element >> size(max/min=100) and damage stiffness around crack. >> > > > > > > >> > > > > > > Anyone has idea to reduce the number of iteration? >> > > > > > > >> > > > > > > Now, I get away with it by using LU, which is not ideal for >> large size problem (I will have to run it in the future) >> > > > > > > >> > > > > > > >> > > > > > > Thanks, >> > > > > > > Josh >> > > > > > > >> > > > > > >> > > > > > >> > > > > >> > > > > >> > > > >> > > > >> > >> > >> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Thu Aug 16 11:33:15 2018 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 16 Aug 2018 12:33:15 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: On Thu, Aug 16, 2018 at 12:32 PM Josh L wrote: > Hi Matt, > > I have solved the error by using MatZeroRowsColumns instead of > MatZeroRows. > Ah, very good. Glad its working. Thanks, Matt > My code is actually using Newton's method to solve nonlinear problem, and > what I do is > impose the Dirichlet BC before calculating the matrix and rhs(residual > vector), and then set the corresponding entries in rhs to zero and zeros > out the rows, so the incremental solution for Dirichlet BC is 0. By doing > so, MatzeroRowsCloumns and MatZeroRows will actually give the same solution. > > Thanks, > Josh > > > > > 2018-08-13 9:13 GMT-05:00 Matthew Knepley : > >> On Sun, Aug 12, 2018 at 11:02 PM Smith, Barry F. >> wrote: >> >>> >>> Sending this to PETSc users because someone else (Mark?) will know why >>> the Eigen estimator fails at iteration 0. >>> >> >> Are you sure its the estimator? That should be GMRES, but the error is >> coming from Chebyshev. >> >> You are remembering to put something on the diagonal of the zeroed rows, >> right? >> >> Matt >> >> >>> I notice you are using a real old version of PETSc, for GAMG which is >>> a fast moving component of PETSc this may fail. You really should work with >>> the latest version of PETSc. Why aren't you? >>> >>> Barry >>> >>> >>> > On Aug 12, 2018, at 9:25 PM, Josh L wrote: >>> > >>> > Hi Barry, >>> > >>> > I set the near null space following the example, but I get error when >>> solving it with -pc_type gamg(no error if solving with default PC). >>> > Moreover, there will be no error if I don't call >>> VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space >>> will not affect iteration number. >>> > >>> > Is it because the way I set Dirichlet boundary conditions? >>> > I just zero out the corresponding row and modify right hand size. >>> > There is no Neumann bc. >>> > >>> > >>> > Thanks, >>> > >>> > The following is the error I get >>> > >>> > [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> > [0]PETSC ERROR: Petsc has generated inconsistent data >>> > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at iteration >>> 0 >>> > [0]PETSC ERROR: See >>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>> shooting. >>> > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 >>> > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell >>> named nid00009 by yslo Sun Aug 12 21:14:17 2018 >>> > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 >>> --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages >>> --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 >>> --with-scalar-type=real --with-shared-libraries=1 --with-precision=double >>> --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 >>> --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack >>> --with-spai=1 --download-spai --with-sundials=1 --download-sundials >>> --with-hdf5=1 >>> --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 >>> --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis >>> --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack >>> --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles >>> --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 >>> --download-superlu_dist --with-superlu=1 --download-superlu >>> --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis >>> --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/ >>> 16.0.1.150/compilers_and_libraries_2016.1.150/linux/mkl >>> --CFLAGS="-xhost -O2 -g" --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" >>> > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/cheby/cheby.c >>> > [0]PETSC ERROR: #2 KSPSolve() line 656 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >>> > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #7 PCApply_MG() line 343 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>> > [0]PETSC ERROR: #8 PCApply() line 482 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/interface/precon.c >>> > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/private/kspimpl.h >>> > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itres.c >>> > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/impls/gmres/gmres.c >>> > [0]PETSC ERROR: #12 KSPSolve() line 656 in >>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/interface/itfunc.c >>> > >>> > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : >>> > >>> > >>> > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: >>> > > >>> > > >>> > > >>> > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : >>> > > >>> > > >>> > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: >>> > > > >>> > > > Hi Barry, >>> > > > >>> > > > I use the example ex49 of KSP(linear elasticity problem), and it's >>> output of ksp monitor is the same as my reduced problem, so I think my code >>> is correct , at least for the reduced problem. >>> > > >>> > > Are you using -pc_type gamg ? >>> > > >>> > > No, just with GMRES and default PC. >>> > > strangely, with gamg, the final solution is still the same but >>> ksp output becomes different between my code and petsc example. >>> > > with -pc_type gamg, my code take 35 iteration and petsc >>> example takes only 7. >>> > >>> > You should use GAMG for elasticity type problems. Does you code set >>> the near null space like the example does? >>> > >>> > > >>> > > Thanks. >>> > > >>> > > >>> > > > >>> > > > Within a Newton's method, several linear system(Ax=b) is solved, >>> and b is the residual vector whose norm becomes smaller and smaller. >>> > > > Should I change rtol for KSP ? since ||b|| is reducing, and >>> converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is >>> rarely satisfied ) >>> > > > I observe that for the first linear solve in Newton's method, >>> iterative solver converges with okay number of iteration >>> > > > , but for the following linear solve, iterative solver takes more >>> and more iterations. >>> > > >>> > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 >>> > > >>> > > Try also -ksp_pc_side right >>> > > >>> > > >>> > > Barry >>> > > >>> > > >>> > > > >>> > > > >>> > > > Thanks, >>> > > > Josh >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : >>> > > > >>> > > > Ok, PCGAMG should work well for linear elasticity so on your >>> reduced problem use -pc_type gamg then the group (Mark) will have specific >>> suggestions for options. We want to see about 20 iterations for >>> "well-behaved" linear elasticity problems. >>> > > > >>> > > > Barry >>> > > > >>> > > > >>> > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: >>> > > > > >>> > > > > Hi Barry, >>> > > > > >>> > > > > Thanks for your help. >>> > > > > >>> > > > > I removed the phase field from my formulation by setting all >>> corresponding degrees of freedom as Dirichlet boundary condition, so >>> > > > > my formulation becomes simply linear elastic. >>> > > > > Then I use CG for KSP and algebraic multigrid for >>> precondiitoner. For a 150K dofs problem, the linear solver converges with >>> 200s iteration(still too much I think), but with GMRES it again takes 2000 >>> iteration to converge. with GMRES and default PC, it barely converges >>> within 10K iteration. >>> > > > > >>> > > > > I will double check my hessian. below is the ksp monitor output >>> from GMRES and gamg PC for first 500 iteration. >>> > > > > >>> > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid >>> norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 >>> > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid >>> norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 >>> > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid >>> norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 >>> > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid >>> norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 >>> > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid >>> norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 >>> > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid >>> norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 >>> > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid >>> norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 >>> > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid >>> norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 >>> > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid >>> norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 >>> > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid >>> norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 >>> > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid >>> norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 >>> > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid >>> norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 >>> > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid >>> norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 >>> > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid >>> norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 >>> > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid >>> norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 >>> > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid >>> norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 >>> > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid >>> norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 >>> > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid >>> norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 >>> > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid >>> norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 >>> > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid >>> norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 >>> > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid >>> norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 >>> > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid >>> norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 >>> > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid >>> norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 >>> > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid >>> norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 >>> > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid >>> norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 >>> > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid >>> norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 >>> > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid >>> norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 >>> > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid >>> norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 >>> > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid >>> norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 >>> > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid >>> norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 >>> > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid >>> norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 >>> > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid >>> norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 >>> > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid >>> norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 >>> > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid >>> norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 >>> > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid >>> norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 >>> > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid >>> norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 >>> > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid >>> norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 >>> > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid >>> norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 >>> > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid >>> norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 >>> > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid >>> norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 >>> > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid >>> norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 >>> > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid >>> norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 >>> > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid >>> norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 >>> > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid >>> norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 >>> > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid >>> norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 >>> > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid >>> norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 >>> > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid >>> norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 >>> > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid >>> norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 >>> > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid >>> norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 >>> > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid >>> norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 >>> > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid >>> norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 >>> > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid >>> norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 >>> > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid >>> norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 >>> > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid >>> norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 >>> > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid >>> norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 >>> > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid >>> norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 >>> > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid >>> norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 >>> > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid >>> norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 >>> > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid >>> norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 >>> > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid >>> norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 >>> > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid >>> norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 >>> > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid >>> norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 >>> > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid >>> norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 >>> > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid >>> norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 >>> > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid >>> norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 >>> > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid >>> norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 >>> > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid >>> norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 >>> > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid >>> norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 >>> > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid >>> norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 >>> > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid >>> norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 >>> > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid >>> norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 >>> > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid >>> norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 >>> > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid >>> norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 >>> > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid >>> norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 >>> > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid >>> norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 >>> > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid >>> norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 >>> > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid >>> norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 >>> > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid >>> norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 >>> > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid >>> norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 >>> > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid >>> norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 >>> > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid >>> norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 >>> > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid >>> norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 >>> > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid >>> norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 >>> > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid >>> norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 >>> > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid >>> norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 >>> > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid >>> norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 >>> > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid >>> norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 >>> > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid >>> norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 >>> > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid >>> norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 >>> > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid >>> norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 >>> > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid >>> norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 >>> > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid >>> norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 >>> > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid >>> norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 >>> > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid >>> norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 >>> > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid >>> norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 >>> > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid >>> norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 >>> > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid >>> norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 >>> > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid >>> norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 >>> > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid >>> norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 >>> > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid >>> norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 >>> > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid >>> norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 >>> > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid >>> norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 >>> > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid >>> norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 >>> > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid >>> norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 >>> > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid >>> norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 >>> > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid >>> norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 >>> > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid >>> norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 >>> > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid >>> norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 >>> > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid >>> norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 >>> > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid >>> norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 >>> > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid >>> norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 >>> > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid >>> norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 >>> > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid >>> norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 >>> > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid >>> norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 >>> > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid >>> norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 >>> > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid >>> norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 >>> > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid >>> norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 >>> > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid >>> norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 >>> > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid >>> norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 >>> > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid >>> norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 >>> > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid >>> norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 >>> > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid >>> norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 >>> > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid >>> norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 >>> > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid >>> norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 >>> > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid >>> norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 >>> > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid >>> norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 >>> > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid >>> norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 >>> > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid >>> norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 >>> > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid >>> norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 >>> > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid >>> norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 >>> > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid >>> norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 >>> > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid >>> norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 >>> > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid >>> norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 >>> > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid >>> norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 >>> > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid >>> norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 >>> > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid >>> norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 >>> > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid >>> norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 >>> > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid >>> norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 >>> > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid >>> norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 >>> > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid >>> norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 >>> > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid >>> norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 >>> > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid >>> norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 >>> > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid >>> norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 >>> > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid >>> norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 >>> > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid >>> norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 >>> > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid >>> norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 >>> > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid >>> norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 >>> > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid >>> norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 >>> > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid >>> norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 >>> > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid >>> norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 >>> > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid >>> norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 >>> > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid >>> norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 >>> > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid >>> norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 >>> > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid >>> norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 >>> > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid >>> norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 >>> > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid >>> norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 >>> > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid >>> norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 >>> > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid >>> norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 >>> > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid >>> norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 >>> > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid >>> norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 >>> > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid >>> norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 >>> > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid >>> norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 >>> > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid >>> norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 >>> > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid >>> norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 >>> > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid >>> norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 >>> > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid >>> norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 >>> > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid >>> norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 >>> > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid >>> norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 >>> > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid >>> norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 >>> > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid >>> norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 >>> > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid >>> norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 >>> > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid >>> norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 >>> > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid >>> norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 >>> > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid >>> norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 >>> > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid >>> norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 >>> > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid >>> norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 >>> > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid >>> norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 >>> > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid >>> norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 >>> > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid >>> norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 >>> > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid >>> norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 >>> > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid >>> norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 >>> > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid >>> norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 >>> > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid >>> norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 >>> > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid >>> norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 >>> > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid >>> norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 >>> > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid >>> norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 >>> > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid >>> norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 >>> > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid >>> norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 >>> > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid >>> norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 >>> > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid >>> norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 >>> > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid >>> norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 >>> > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid >>> norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 >>> > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid >>> norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 >>> > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid >>> norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 >>> > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid >>> norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 >>> > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid >>> norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 >>> > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid >>> norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 >>> > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid >>> norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 >>> > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid >>> norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 >>> > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid >>> norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 >>> > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid >>> norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 >>> > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid >>> norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 >>> > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid >>> norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 >>> > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid >>> norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 >>> > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid >>> norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 >>> > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid >>> norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 >>> > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid >>> norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 >>> > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid >>> norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 >>> > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid >>> norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 >>> > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid >>> norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 >>> > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid >>> norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 >>> > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid >>> norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 >>> > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid >>> norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 >>> > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid >>> norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 >>> > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid >>> norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 >>> > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid >>> norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 >>> > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid >>> norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 >>> > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid >>> norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 >>> > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid >>> norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 >>> > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid >>> norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 >>> > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid >>> norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 >>> > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid >>> norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 >>> > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid >>> norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 >>> > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid >>> norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 >>> > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid >>> norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 >>> > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid >>> norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 >>> > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid >>> norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 >>> > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid >>> norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 >>> > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid >>> norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 >>> > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid >>> norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 >>> > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid >>> norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 >>> > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid >>> norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 >>> > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid >>> norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 >>> > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid >>> norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 >>> > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid >>> norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 >>> > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid >>> norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 >>> > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid >>> norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 >>> > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid >>> norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 >>> > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid >>> norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 >>> > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid >>> norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 >>> > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid >>> norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 >>> > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid >>> norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 >>> > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid >>> norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 >>> > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid >>> norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 >>> > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid >>> norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 >>> > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid >>> norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 >>> > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid >>> norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 >>> > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid >>> norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 >>> > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid >>> norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 >>> > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid >>> norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 >>> > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid >>> norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 >>> > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid >>> norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 >>> > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid >>> norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 >>> > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid >>> norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 >>> > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid >>> norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 >>> > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid >>> norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 >>> > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid >>> norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 >>> > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid >>> norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 >>> > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid >>> norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 >>> > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid >>> norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 >>> > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid >>> norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 >>> > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid >>> norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 >>> > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid >>> norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 >>> > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid >>> norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 >>> > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid >>> norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 >>> > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid >>> norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 >>> > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid >>> norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 >>> > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid >>> norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 >>> > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid >>> norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 >>> > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid >>> norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 >>> > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid >>> norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 >>> > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid >>> norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 >>> > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid >>> norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 >>> > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid >>> norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 >>> > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid >>> norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 >>> > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid >>> norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 >>> > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid >>> norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 >>> > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid >>> norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 >>> > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid >>> norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 >>> > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid >>> norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 >>> > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid >>> norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 >>> > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid >>> norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 >>> > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid >>> norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 >>> > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid >>> norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 >>> > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid >>> norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 >>> > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid >>> norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 >>> > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid >>> norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 >>> > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid >>> norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 >>> > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid >>> norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 >>> > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid >>> norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 >>> > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid >>> norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 >>> > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid >>> norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 >>> > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid >>> norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 >>> > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid >>> norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 >>> > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid >>> norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 >>> > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid >>> norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 >>> > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid >>> norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 >>> > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid >>> norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 >>> > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid >>> norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 >>> > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid >>> norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 >>> > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid >>> norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 >>> > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid >>> norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 >>> > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid >>> norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 >>> > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid >>> norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 >>> > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid >>> norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 >>> > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid >>> norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 >>> > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid >>> norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 >>> > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid >>> norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 >>> > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid >>> norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 >>> > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid >>> norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 >>> > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid >>> norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 >>> > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid >>> norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 >>> > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid >>> norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 >>> > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid >>> norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 >>> > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid >>> norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 >>> > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid >>> norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 >>> > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid >>> norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 >>> > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid >>> norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 >>> > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid >>> norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 >>> > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid >>> norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 >>> > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid >>> norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 >>> > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid >>> norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 >>> > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid >>> norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 >>> > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid >>> norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 >>> > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid >>> norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 >>> > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid >>> norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 >>> > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid >>> norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 >>> > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid >>> norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 >>> > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid >>> norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 >>> > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid >>> norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 >>> > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid >>> norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 >>> > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid >>> norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 >>> > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid >>> norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 >>> > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid >>> norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 >>> > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid >>> norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 >>> > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid >>> norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 >>> > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid >>> norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 >>> > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid >>> norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 >>> > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid >>> norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 >>> > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid >>> norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 >>> > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid >>> norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 >>> > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid >>> norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 >>> > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid >>> norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 >>> > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid >>> norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 >>> > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid >>> norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 >>> > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid >>> norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 >>> > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid >>> norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 >>> > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid >>> norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 >>> > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid >>> norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 >>> > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid >>> norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 >>> > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid >>> norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 >>> > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid >>> norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 >>> > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid >>> norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 >>> > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid >>> norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 >>> > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid >>> norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 >>> > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid >>> norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 >>> > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid >>> norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 >>> > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid >>> norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 >>> > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid >>> norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 >>> > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid >>> norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 >>> > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid >>> norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 >>> > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid >>> norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 >>> > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid >>> norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 >>> > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid >>> norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 >>> > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid >>> norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 >>> > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid >>> norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 >>> > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid >>> norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 >>> > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid >>> norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 >>> > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid >>> norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 >>> > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid >>> norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 >>> > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid >>> norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 >>> > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid >>> norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 >>> > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid >>> norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 >>> > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid >>> norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 >>> > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid >>> norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 >>> > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid >>> norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 >>> > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid >>> norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 >>> > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid >>> norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 >>> > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid >>> norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 >>> > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid >>> norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 >>> > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid >>> norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 >>> > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid >>> norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 >>> > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid >>> norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 >>> > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid >>> norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 >>> > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid >>> norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 >>> > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid >>> norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 >>> > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid >>> norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 >>> > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid >>> norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 >>> > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid >>> norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 >>> > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid >>> norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 >>> > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid >>> norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 >>> > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid >>> norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 >>> > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid >>> norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 >>> > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid >>> norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 >>> > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid >>> norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 >>> > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid >>> norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 >>> > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid >>> norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 >>> > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid >>> norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 >>> > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid >>> norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 >>> > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid >>> norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 >>> > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid >>> norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 >>> > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid >>> norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 >>> > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid >>> norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 >>> > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid >>> norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 >>> > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid >>> norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 >>> > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid >>> norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 >>> > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid >>> norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 >>> > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid >>> norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 >>> > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid >>> norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 >>> > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid >>> norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 >>> > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid >>> norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 >>> > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid >>> norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 >>> > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid >>> norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 >>> > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid >>> norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 >>> > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid >>> norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 >>> > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid >>> norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 >>> > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid >>> norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 >>> > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid >>> norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 >>> > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid >>> norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 >>> > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid >>> norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 >>> > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid >>> norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 >>> > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid >>> norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 >>> > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid >>> norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 >>> > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid >>> norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 >>> > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid >>> norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 >>> > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid >>> norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 >>> > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid >>> norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 >>> > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid >>> norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 >>> > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid >>> norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 >>> > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid >>> norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 >>> > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid >>> norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 >>> > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid >>> norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 >>> > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid >>> norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 >>> > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid >>> norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 >>> > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid >>> norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 >>> > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid >>> norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 >>> > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid >>> norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 >>> > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid >>> norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 >>> > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid >>> norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 >>> > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid >>> norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 >>> > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid >>> norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 >>> > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid >>> norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 >>> > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid >>> norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 >>> > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid >>> norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 >>> > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid >>> norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 >>> > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid >>> norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 >>> > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid >>> norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 >>> > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid >>> norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 >>> > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid >>> norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 >>> > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid >>> norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 >>> > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid >>> norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 >>> > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid >>> norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 >>> > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid >>> norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 >>> > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid >>> norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 >>> > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid >>> norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 >>> > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid >>> norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 >>> > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid >>> norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 >>> > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid >>> norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 >>> > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid >>> norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 >>> > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid >>> norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 >>> > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid >>> norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 >>> > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid >>> norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 >>> > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid >>> norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 >>> > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid >>> norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 >>> > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid >>> norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 >>> > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid >>> norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 >>> > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid >>> norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 >>> > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid >>> norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 >>> > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid >>> norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 >>> > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid >>> norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 >>> > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid >>> norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 >>> > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid >>> norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 >>> > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid >>> norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 >>> > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid >>> norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 >>> > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid >>> norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 >>> > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid >>> norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 >>> > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid >>> norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 >>> > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid >>> norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 >>> > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid >>> norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 >>> > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid >>> norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 >>> > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid >>> norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 >>> > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid >>> norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 >>> > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid >>> norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 >>> > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid >>> norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 >>> > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid >>> norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 >>> > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid >>> norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 >>> > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid >>> norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 >>> > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid >>> norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 >>> > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid >>> norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 >>> > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid >>> norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 >>> > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid >>> norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 >>> > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid >>> norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 >>> > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid >>> norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 >>> > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid >>> norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 >>> > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid >>> norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 >>> > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid >>> norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 >>> > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid >>> norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 >>> > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid >>> norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 >>> > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid >>> norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 >>> > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid >>> norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 >>> > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid >>> norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. : >>> > > > > >>> > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u >>> and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) >>> for each field. Then try replacing the direct solvers LU with hypre >>> BoomerAMG first one at a time. >>> > > > > >>> > > > > Let us know how it goes and we'll make additional >>> suggestions, >>> > > > > >>> > > > > Barry >>> > > > > >>> > > > > >>> > > > > > On Aug 6, 2018, at 12:58 PM, Josh L >>> wrote: >>> > > > > > >>> > > > > > Hi Barry, >>> > > > > > >>> > > > > > (1) >>> > > > > > I am basically solving the equilibrium coupled with phase >>> field equation: >>> > > > > > >>> > > > > > 1-D example >>> > > > > > u is displacement and c is phase-field parameter. >>> > > > > > >>> > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 >>> > > > > > >>> > > > > > phase-field equation: 2*G_c*L*(\Delta >>> c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 >>> > > > > > >>> > > > > > I solve the above 2 equations coupled. >>> > > > > > it is the formulation for quasi-static fracture problem, where >>> G_c is the critical energy release rate and L is the length scale in >>> phase-field method (both constant). >>> > > > > > >>> > > > > > The free energy I am using now is >>> > > > > > 1-D: >>> > > > > > >>> > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad c >>> > > > > > >>> > > > > > >>> > > > > > it is not convex w.r.t u and c simultaneously. >>> > > > > > >>> > > > > > (2) >>> > > > > > >>> > > > > > with an appropriate step size. Newton's method usually >>> converges with 5 iteration, and I can see the quadratic convergence of >>> Newton's method. >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > Thanks, >>> > > > > > Josh >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. >> >: >>> > > > > > >>> > > > > > >>> > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L >>> wrote: >>> > > > > > > >>> > > > > > > Hi, >>> > > > > > > >>> > > > > > > I am using GRMES to solve the linear systems within Newton >>> Raphson. >>> > > > > > > I am using finite element method to solve fracture problem >>> with phase field method.(the formulation gives symmetric but indefinite >>> hessian so can't use CG) >>> > > > > > >>> > > > > > What exact equations are you using for the phase field >>> method? >>> > > > > > >>> > > > > > With the direct LU solver roughly how many iterations >>> does your Newton's method take? >>> > > > > > >>> > > > > > >>> > > > > > Barry >>> > > > > > >>> > > > > > > >>> > > > > > > The total iteration number to solve one linear system is >>> often very large( > 2000) even for a small sized problem(120K degree of >>> freedom). I've tried different preconditioner, but it doesn't help a lot. >>> I have checked my hessian and right hand side, and sure they are correct. >>> > > > > > > >>> > > > > > > I think it might stem from the great difference in element >>> size(max/min=100) and damage stiffness around crack. >>> > > > > > > >>> > > > > > > Anyone has idea to reduce the number of iteration? >>> > > > > > > >>> > > > > > > Now, I get away with it by using LU, which is not ideal for >>> large size problem (I will have to run it in the future) >>> > > > > > > >>> > > > > > > >>> > > > > > > Thanks, >>> > > > > > > Josh >>> > > > > > > >>> > > > > > >>> > > > > > >>> > > > > >>> > > > > >>> > > > >>> > > > >>> > >>> > >>> >>> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From ysjosh.lo at gmail.com Wed Aug 15 19:37:57 2018 From: ysjosh.lo at gmail.com (Josh L) Date: Wed, 15 Aug 2018 19:37:57 -0500 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: Hi Matt, Attach is the matrix and rhs in binary format. I really appreciate your help. Thanks, Josh 2018-08-13 10:28 GMT-05:00 Matthew Knepley : > On Mon, Aug 13, 2018 at 11:25 AM Josh L wrote: > >> Hi Matt, >> >> Yes, the diagonal term is set to 1.0 >> > > Can you send the matrix and rhs? I think you can output them using > > -ksp_view_mat binary:system.bin -ksp_view_rhs binary:system.bin::append > > and then we can run exactly what you do in KSP ex10. > > Thanks, > > Matt > > >> Thanks, >> Josh >> >> >> 2018-08-13 9:13 GMT-05:00 Matthew Knepley : >> >>> On Sun, Aug 12, 2018 at 11:02 PM Smith, Barry F. >>> wrote: >>> >>>> >>>> Sending this to PETSc users because someone else (Mark?) will know >>>> why the Eigen estimator fails at iteration 0. >>>> >>> >>> Are you sure its the estimator? That should be GMRES, but the error is >>> coming from Chebyshev. >>> >>> You are remembering to put something on the diagonal of the zeroed rows, >>> right? >>> >>> Matt >>> >>> >>>> I notice you are using a real old version of PETSc, for GAMG which >>>> is a fast moving component of PETSc this may fail. You really should work >>>> with the latest version of PETSc. Why aren't you? >>>> >>>> Barry >>>> >>>> >>>> > On Aug 12, 2018, at 9:25 PM, Josh L wrote: >>>> > >>>> > Hi Barry, >>>> > >>>> > I set the near null space following the example, but I get error when >>>> solving it with -pc_type gamg(no error if solving with default PC). >>>> > Moreover, there will be no error if I don't call >>>> VecSetBlockSize(vec_coord,2) (it is a 2-D problem), but the near null space >>>> will not affect iteration number. >>>> > >>>> > Is it because the way I set Dirichlet boundary conditions? >>>> > I just zero out the corresponding row and modify right hand size. >>>> > There is no Neumann bc. >>>> > >>>> > >>>> > Thanks, >>>> > >>>> > The following is the error I get >>>> > >>>> > [0]PETSC ERROR: --------------------- Error Message >>>> -------------------------------------------------------------- >>>> > [0]PETSC ERROR: Petsc has generated inconsistent data >>>> > [0]PETSC ERROR: Eigen estimator failed: DIVERGED_NANORINF at >>>> iteration 0 >>>> > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>> documentation/faq.html for trouble shooting. >>>> > [0]PETSC ERROR: Petsc Release Version 3.7.5, Jan, 01, 2017 >>>> > [0]PETSC ERROR: /work/03691/yslo/lonestar/inex/crack on a haswell >>>> named nid00009 by yslo Sun Aug 12 21:14:17 2018 >>>> > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-np=8 >>>> --with-external-packages-dir=/opt/apps/intel16/cray_mpich_7_3/petsc/3.7/externalpackages >>>> --with-mpi-compilers=1 --with-mpi-dir=/opt/apps/intel16/cray_mpich/7.3.0 >>>> --with-scalar-type=real --with-shared-libraries=1 --with-precision=double >>>> --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-ml=1 >>>> --download-ml --with-ml=1 --download-ml --with-plapack=1 --download-plapack >>>> --with-spai=1 --download-spai --with-sundials=1 --download-sundials >>>> --with-hdf5=1 --with-hdf5-dir=/opt/apps/intel16/cray_mpich_7_2/phdf5/1.8.16/x86_64 >>>> --with-mumps=1 --download-mumps --with-parmetis=1 --download-parmetis >>>> --with-metis=1 --download-metis --with-scalapack=1 --download-scalapack >>>> --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles >>>> --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 >>>> --download-superlu_dist --with-superlu=1 --download-superlu >>>> --with-parmetis=1 --download-parmetis --with-metis=1 --download-metis >>>> --with-debugging=no --with-blas-lapack-dir=/opt/apps/intel/16.0.1.150/ >>>> compilers_and_libraries_2016.1.150/linux/mkl --CFLAGS="-xhost -O2 -g" >>>> --FFLAGS="-xhost -O2 -g" --CXXFLAGS="-xhost -O2 -g" >>>> > [0]PETSC ERROR: #1 KSPSolve_Chebyshev() line 440 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >>>> impls/cheby/cheby.c >>>> > [0]PETSC ERROR: #2 KSPSolve() line 656 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >>>> interface/itfunc.c >>>> > [0]PETSC ERROR: #3 PCMGMCycle_Private() line 21 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>>> > [0]PETSC ERROR: #4 PCMGMCycle_Private() line 55 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>>> > [0]PETSC ERROR: #5 PCMGMCycle_Private() line 55 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>>> > [0]PETSC ERROR: #6 PCMGMCycle_Private() line 55 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>>> > [0]PETSC ERROR: #7 PCApply_MG() line 343 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/pc/impls/mg/mg.c >>>> > [0]PETSC ERROR: #8 PCApply() line 482 in /opt/apps/intel16/cray_mpich_ >>>> 7_3/petsc/3.7/src/ksp/pc/interface/precon.c >>>> > [0]PETSC ERROR: #9 KSP_PCApply() line 244 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/include/petsc/ >>>> private/kspimpl.h >>>> > [0]PETSC ERROR: #10 KSPInitialResidual() line 69 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >>>> interface/itres.c >>>> > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 239 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >>>> impls/gmres/gmres.c >>>> > [0]PETSC ERROR: #12 KSPSolve() line 656 in >>>> /opt/apps/intel16/cray_mpich_7_3/petsc/3.7/src/ksp/ksp/ >>>> interface/itfunc.c >>>> > >>>> > 2018-08-11 14:27 GMT-05:00 Smith, Barry F. : >>>> > >>>> > >>>> > > On Aug 9, 2018, at 9:11 PM, Josh L wrote: >>>> > > >>>> > > >>>> > > >>>> > > 2018-08-09 18:47 GMT-05:00 Smith, Barry F. : >>>> > > >>>> > > >>>> > > > On Aug 9, 2018, at 3:03 PM, Josh L wrote: >>>> > > > >>>> > > > Hi Barry, >>>> > > > >>>> > > > I use the example ex49 of KSP(linear elasticity problem), and >>>> it's output of ksp monitor is the same as my reduced problem, so I think my >>>> code is correct , at least for the reduced problem. >>>> > > >>>> > > Are you using -pc_type gamg ? >>>> > > >>>> > > No, just with GMRES and default PC. >>>> > > strangely, with gamg, the final solution is still the same >>>> but ksp output becomes different between my code and petsc example. >>>> > > with -pc_type gamg, my code take 35 iteration and petsc >>>> example takes only 7. >>>> > >>>> > You should use GAMG for elasticity type problems. Does you code >>>> set the near null space like the example does? >>>> > >>>> > > >>>> > > Thanks. >>>> > > >>>> > > >>>> > > > >>>> > > > Within a Newton's method, several linear system(Ax=b) is solved, >>>> and b is the residual vector whose norm becomes smaller and smaller. >>>> > > > Should I change rtol for KSP ? since ||b|| is reducing, and >>>> converge requires ||b-Ax|| / ||b|| < rtol ( || b - Ax || < atol=10^-50 is >>>> rarely satisfied ) >>>> > > > I observe that for the first linear solve in Newton's method, >>>> iterative solver converges with okay number of iteration >>>> > > > , but for the following linear solve, iterative solver takes more >>>> and more iterations. >>>> > > >>>> > > You can probably get away with -ksp_rtol 1.e-3 or even try 1.e-2 >>>> > > >>>> > > Try also -ksp_pc_side right >>>> > > >>>> > > >>>> > > Barry >>>> > > >>>> > > >>>> > > > >>>> > > > >>>> > > > Thanks, >>>> > > > Josh >>>> > > > >>>> > > > >>>> > > > >>>> > > > >>>> > > > 2018-08-09 10:26 GMT-05:00 Smith, Barry F. : >>>> > > > >>>> > > > Ok, PCGAMG should work well for linear elasticity so on your >>>> reduced problem use -pc_type gamg then the group (Mark) will have specific >>>> suggestions for options. We want to see about 20 iterations for >>>> "well-behaved" linear elasticity problems. >>>> > > > >>>> > > > Barry >>>> > > > >>>> > > > >>>> > > > > On Aug 8, 2018, at 5:48 PM, Josh L wrote: >>>> > > > > >>>> > > > > Hi Barry, >>>> > > > > >>>> > > > > Thanks for your help. >>>> > > > > >>>> > > > > I removed the phase field from my formulation by setting all >>>> corresponding degrees of freedom as Dirichlet boundary condition, so >>>> > > > > my formulation becomes simply linear elastic. >>>> > > > > Then I use CG for KSP and algebraic multigrid for >>>> precondiitoner. For a 150K dofs problem, the linear solver converges with >>>> 200s iteration(still too much I think), but with GMRES it again takes 2000 >>>> iteration to converge. with GMRES and default PC, it barely converges >>>> within 10K iteration. >>>> > > > > >>>> > > > > I will double check my hessian. below is the ksp monitor >>>> output from GMRES and gamg PC for first 500 iteration. >>>> > > > > >>>> > > > > 0 KSP preconditioned resid norm 9.175598437886e-07 true resid >>>> norm 4.423520976130e-07 ||r(i)||/||b|| 1.000000000000e+00 >>>> > > > > 1 KSP preconditioned resid norm 9.171756840415e-07 true resid >>>> norm 4.185847348836e-07 ||r(i)||/||b|| 9.462704871128e-01 >>>> > > > > 2 KSP preconditioned resid norm 9.171436192115e-07 true resid >>>> norm 4.373193748329e-07 ||r(i)||/||b|| 9.886228124446e-01 >>>> > > > > 3 KSP preconditioned resid norm 9.047636402661e-07 true resid >>>> norm 2.655845586443e-07 ||r(i)||/||b|| 6.003917695371e-01 >>>> > > > > 4 KSP preconditioned resid norm 9.032722605019e-07 true resid >>>> norm 3.045614764490e-07 ||r(i)||/||b|| 6.885046506899e-01 >>>> > > > > 5 KSP preconditioned resid norm 8.926003608855e-07 true resid >>>> norm 3.498775710352e-07 ||r(i)||/||b|| 7.909481449805e-01 >>>> > > > > 6 KSP preconditioned resid norm 8.788553543841e-07 true resid >>>> norm 2.052341235884e-07 ||r(i)||/||b|| 4.639610045841e-01 >>>> > > > > 7 KSP preconditioned resid norm 8.725201948474e-07 true resid >>>> norm 3.315801151567e-07 ||r(i)||/||b|| 7.495841365870e-01 >>>> > > > > 8 KSP preconditioned resid norm 8.704702843041e-07 true resid >>>> norm 2.453167687304e-07 ||r(i)||/||b|| 5.545735400696e-01 >>>> > > > > 9 KSP preconditioned resid norm 8.673295560357e-07 true resid >>>> norm 3.480581533019e-07 ||r(i)||/||b|| 7.868350917291e-01 >>>> > > > > 10 KSP preconditioned resid norm 8.650826882165e-07 true resid >>>> norm 3.331076551593e-07 ||r(i)||/||b|| 7.530373586036e-01 >>>> > > > > 11 KSP preconditioned resid norm 8.632977966037e-07 true resid >>>> norm 2.943531620635e-07 ||r(i)||/||b|| 6.654273002250e-01 >>>> > > > > 12 KSP preconditioned resid norm 8.622407761375e-07 true resid >>>> norm 3.413473413778e-07 ||r(i)||/||b|| 7.716643443532e-01 >>>> > > > > 13 KSP preconditioned resid norm 8.612343318250e-07 true resid >>>> norm 2.962692292083e-07 ||r(i)||/||b|| 6.697588432541e-01 >>>> > > > > 14 KSP preconditioned resid norm 8.579354639983e-07 true resid >>>> norm 3.298514619407e-07 ||r(i)||/||b|| 7.456762694710e-01 >>>> > > > > 15 KSP preconditioned resid norm 8.578914052098e-07 true resid >>>> norm 3.287293954137e-07 ||r(i)||/||b|| 7.431396780699e-01 >>>> > > > > 16 KSP preconditioned resid norm 8.564349944906e-07 true resid >>>> norm 3.231662390796e-07 ||r(i)||/||b|| 7.305633698212e-01 >>>> > > > > 17 KSP preconditioned resid norm 8.544772830576e-07 true resid >>>> norm 3.522175745975e-07 ||r(i)||/||b|| 7.962380567383e-01 >>>> > > > > 18 KSP preconditioned resid norm 8.518664697660e-07 true resid >>>> norm 2.957457436154e-07 ||r(i)||/||b|| 6.685754294176e-01 >>>> > > > > 19 KSP preconditioned resid norm 8.502444318835e-07 true resid >>>> norm 3.231647326483e-07 ||r(i)||/||b|| 7.305599643183e-01 >>>> > > > > 20 KSP preconditioned resid norm 8.488626061229e-07 true resid >>>> norm 3.034773190650e-07 ||r(i)||/||b|| 6.860537583129e-01 >>>> > > > > 21 KSP preconditioned resid norm 8.472536047506e-07 true resid >>>> norm 3.142174821592e-07 ||r(i)||/||b|| 7.103334286301e-01 >>>> > > > > 22 KSP preconditioned resid norm 8.465622251926e-07 true resid >>>> norm 3.109996301173e-07 ||r(i)||/||b|| 7.030590151951e-01 >>>> > > > > 23 KSP preconditioned resid norm 8.455410030133e-07 true resid >>>> norm 3.026169375479e-07 ||r(i)||/||b|| 6.841087431955e-01 >>>> > > > > 24 KSP preconditioned resid norm 8.441686432481e-07 true resid >>>> norm 3.247156730398e-07 ||r(i)||/||b|| 7.340660862513e-01 >>>> > > > > 25 KSP preconditioned resid norm 8.422635872670e-07 true resid >>>> norm 2.949977317008e-07 ||r(i)||/||b|| 6.668844418115e-01 >>>> > > > > 26 KSP preconditioned resid norm 8.391013229654e-07 true resid >>>> norm 3.503429354312e-07 ||r(i)||/||b|| 7.920001675626e-01 >>>> > > > > 27 KSP preconditioned resid norm 8.369135179081e-07 true resid >>>> norm 2.932796516614e-07 ||r(i)||/||b|| 6.630004768691e-01 >>>> > > > > 28 KSP preconditioned resid norm 8.344557411519e-07 true resid >>>> norm 3.290576497205e-07 ||r(i)||/||b|| 7.438817437425e-01 >>>> > > > > 29 KSP preconditioned resid norm 8.255611852636e-07 true resid >>>> norm 3.228082527538e-07 ||r(i)||/||b|| 7.297540906796e-01 >>>> > > > > 30 KSP preconditioned resid norm 8.191145448615e-07 true resid >>>> norm 2.695709281706e-07 ||r(i)||/||b|| 6.094035263430e-01 >>>> > > > > 31 KSP preconditioned resid norm 8.190911648438e-07 true resid >>>> norm 2.661586473845e-07 ||r(i)||/||b|| 6.016895790044e-01 >>>> > > > > 32 KSP preconditioned resid norm 8.188934260789e-07 true resid >>>> norm 3.000926727757e-07 ||r(i)||/||b|| 6.784022826953e-01 >>>> > > > > 33 KSP preconditioned resid norm 8.166449659697e-07 true resid >>>> norm 2.081220810731e-07 ||r(i)||/||b|| 4.704896443267e-01 >>>> > > > > 34 KSP preconditioned resid norm 8.130668560598e-07 true resid >>>> norm 3.175998062677e-07 ||r(i)||/||b|| 7.179796546271e-01 >>>> > > > > 35 KSP preconditioned resid norm 8.103250854289e-07 true resid >>>> norm 2.675762536241e-07 ||r(i)||/||b|| 6.048942800723e-01 >>>> > > > > 36 KSP preconditioned resid norm 8.079447876546e-07 true resid >>>> norm 2.624343353237e-07 ||r(i)||/||b|| 5.932702404709e-01 >>>> > > > > 37 KSP preconditioned resid norm 8.064590891986e-07 true resid >>>> norm 2.891085928184e-07 ||r(i)||/||b|| 6.535712035243e-01 >>>> > > > > 38 KSP preconditioned resid norm 8.039981484367e-07 true resid >>>> norm 2.435760434885e-07 ||r(i)||/||b|| 5.506383824173e-01 >>>> > > > > 39 KSP preconditioned resid norm 8.030132361660e-07 true resid >>>> norm 2.791572408348e-07 ||r(i)||/||b|| 6.310747532139e-01 >>>> > > > > 40 KSP preconditioned resid norm 8.025869823713e-07 true resid >>>> norm 2.673367609434e-07 ||r(i)||/||b|| 6.043528727137e-01 >>>> > > > > 41 KSP preconditioned resid norm 8.011717744772e-07 true resid >>>> norm 2.626259645676e-07 ||r(i)||/||b|| 5.937034457049e-01 >>>> > > > > 42 KSP preconditioned resid norm 7.994420264672e-07 true resid >>>> norm 2.931234480129e-07 ||r(i)||/||b|| 6.626473562454e-01 >>>> > > > > 43 KSP preconditioned resid norm 7.976276065412e-07 true resid >>>> norm 2.565425485040e-07 ||r(i)||/||b|| 5.799510161438e-01 >>>> > > > > 44 KSP preconditioned resid norm 7.963529254232e-07 true resid >>>> norm 2.683594511633e-07 ||r(i)||/||b|| 6.066648098007e-01 >>>> > > > > 45 KSP preconditioned resid norm 7.951914923472e-07 true resid >>>> norm 2.726317559874e-07 ||r(i)||/||b|| 6.163229641241e-01 >>>> > > > > 46 KSP preconditioned resid norm 7.943011197327e-07 true resid >>>> norm 2.561291446355e-07 ||r(i)||/||b|| 5.790164577440e-01 >>>> > > > > 47 KSP preconditioned resid norm 7.926385476568e-07 true resid >>>> norm 2.978344787798e-07 ||r(i)||/||b|| 6.732973131290e-01 >>>> > > > > 48 KSP preconditioned resid norm 7.909780991424e-07 true resid >>>> norm 2.498059973427e-07 ||r(i)||/||b|| 5.647220815515e-01 >>>> > > > > 49 KSP preconditioned resid norm 7.863002375447e-07 true resid >>>> norm 3.283898230799e-07 ||r(i)||/||b|| 7.423720263834e-01 >>>> > > > > 50 KSP preconditioned resid norm 7.778093966862e-07 true resid >>>> norm 2.908211438411e-07 ||r(i)||/||b|| 6.574426693360e-01 >>>> > > > > 51 KSP preconditioned resid norm 7.727705792892e-07 true resid >>>> norm 2.662262655905e-07 ||r(i)||/||b|| 6.018424396020e-01 >>>> > > > > 52 KSP preconditioned resid norm 7.580949386500e-07 true resid >>>> norm 4.077725304210e-07 ||r(i)||/||b|| 9.218279570084e-01 >>>> > > > > 53 KSP preconditioned resid norm 7.223569984502e-07 true resid >>>> norm 2.806806877450e-07 ||r(i)||/||b|| 6.345187222115e-01 >>>> > > > > 54 KSP preconditioned resid norm 6.833104315428e-07 true resid >>>> norm 3.167664065828e-07 ||r(i)||/||b|| 7.160956357890e-01 >>>> > > > > 55 KSP preconditioned resid norm 6.480813314286e-07 true resid >>>> norm 3.449389182846e-07 ||r(i)||/||b|| 7.797836161419e-01 >>>> > > > > 56 KSP preconditioned resid norm 5.628534804207e-07 true resid >>>> norm 5.008589310744e-07 ||r(i)||/||b|| 1.132263040635e+00 >>>> > > > > 57 KSP preconditioned resid norm 4.676624755957e-07 true resid >>>> norm 2.747589656053e-07 ||r(i)||/||b|| 6.211318248245e-01 >>>> > > > > 58 KSP preconditioned resid norm 4.266847724428e-07 true resid >>>> norm 2.051356033363e-07 ||r(i)||/||b|| 4.637382855043e-01 >>>> > > > > 59 KSP preconditioned resid norm 3.963440719602e-07 true resid >>>> norm 1.462894974865e-07 ||r(i)||/||b|| 3.307082712524e-01 >>>> > > > > 60 KSP preconditioned resid norm 3.710732500804e-07 true resid >>>> norm 2.006153077396e-07 ||r(i)||/||b|| 4.535195126737e-01 >>>> > > > > 61 KSP preconditioned resid norm 3.700288732490e-07 true resid >>>> norm 1.637656172799e-07 ||r(i)||/||b|| 3.702155322956e-01 >>>> > > > > 62 KSP preconditioned resid norm 3.681230892718e-07 true resid >>>> norm 2.598403207310e-07 ||r(i)||/||b|| 5.874061005545e-01 >>>> > > > > 63 KSP preconditioned resid norm 3.447874366524e-07 true resid >>>> norm 9.834277028700e-08 ||r(i)||/||b|| 2.223178567880e-01 >>>> > > > > 64 KSP preconditioned resid norm 3.308954457293e-07 true resid >>>> norm 8.462173093522e-08 ||r(i)||/||b|| 1.912994905910e-01 >>>> > > > > 65 KSP preconditioned resid norm 3.238105866460e-07 true resid >>>> norm 1.508442004566e-07 ||r(i)||/||b|| 3.410048268575e-01 >>>> > > > > 66 KSP preconditioned resid norm 3.149261250545e-07 true resid >>>> norm 6.146735546031e-08 ||r(i)||/||b|| 1.389557228100e-01 >>>> > > > > 67 KSP preconditioned resid norm 3.080685419183e-07 true resid >>>> norm 1.469742604456e-07 ||r(i)||/||b|| 3.322562755748e-01 >>>> > > > > 68 KSP preconditioned resid norm 3.017036477950e-07 true resid >>>> norm 8.246002370676e-08 ||r(i)||/||b|| 1.864126431224e-01 >>>> > > > > 69 KSP preconditioned resid norm 2.951373085123e-07 true resid >>>> norm 9.600472070625e-08 ||r(i)||/||b|| 2.170323622840e-01 >>>> > > > > 70 KSP preconditioned resid norm 2.854303567501e-07 true resid >>>> norm 1.353606365274e-07 ||r(i)||/||b|| 3.060020225015e-01 >>>> > > > > 71 KSP preconditioned resid norm 2.720605973489e-07 true resid >>>> norm 7.105192119695e-08 ||r(i)||/||b|| 1.606230005020e-01 >>>> > > > > 72 KSP preconditioned resid norm 2.679746464067e-07 true resid >>>> norm 1.093157769657e-07 ||r(i)||/||b|| 2.471239032336e-01 >>>> > > > > 73 KSP preconditioned resid norm 2.560436669192e-07 true resid >>>> norm 1.046442873472e-07 ||r(i)||/||b|| 2.365633347550e-01 >>>> > > > > 74 KSP preconditioned resid norm 2.486272155786e-07 true resid >>>> norm 6.788331443968e-08 ||r(i)||/||b|| 1.534599130557e-01 >>>> > > > > 75 KSP preconditioned resid norm 2.450613653917e-07 true resid >>>> norm 8.385393991346e-08 ||r(i)||/||b|| 1.895637894925e-01 >>>> > > > > 76 KSP preconditioned resid norm 2.381548789947e-07 true resid >>>> norm 9.639184405623e-08 ||r(i)||/||b|| 2.179075098239e-01 >>>> > > > > 77 KSP preconditioned resid norm 2.318084665470e-07 true resid >>>> norm 5.817254053914e-08 ||r(i)||/||b|| 1.315073238107e-01 >>>> > > > > 78 KSP preconditioned resid norm 2.301457113250e-07 true resid >>>> norm 7.214348778091e-08 ||r(i)||/||b|| 1.630906424322e-01 >>>> > > > > 79 KSP preconditioned resid norm 2.288069605204e-07 true resid >>>> norm 6.520316797685e-08 ||r(i)||/||b|| 1.474010597637e-01 >>>> > > > > 80 KSP preconditioned resid norm 2.272182407377e-07 true resid >>>> norm 6.553558340584e-08 ||r(i)||/||b|| 1.481525322463e-01 >>>> > > > > 81 KSP preconditioned resid norm 2.261791202938e-07 true resid >>>> norm 6.410731366977e-08 ||r(i)||/||b|| 1.449237248240e-01 >>>> > > > > 82 KSP preconditioned resid norm 2.250209367027e-07 true resid >>>> norm 6.108112632184e-08 ||r(i)||/||b|| 1.380825967627e-01 >>>> > > > > 83 KSP preconditioned resid norm 2.237071893420e-07 true resid >>>> norm 6.644497913123e-08 ||r(i)||/||b|| 1.502083509715e-01 >>>> > > > > 84 KSP preconditioned resid norm 2.234300550868e-07 true resid >>>> norm 5.793844170260e-08 ||r(i)||/||b|| 1.309781100061e-01 >>>> > > > > 85 KSP preconditioned resid norm 2.229005171876e-07 true resid >>>> norm 6.926007074308e-08 ||r(i)||/||b|| 1.565722670172e-01 >>>> > > > > 86 KSP preconditioned resid norm 2.225791427950e-07 true resid >>>> norm 6.289120214757e-08 ||r(i)||/||b|| 1.421745312997e-01 >>>> > > > > 87 KSP preconditioned resid norm 2.224479658210e-07 true resid >>>> norm 6.242310048343e-08 ||r(i)||/||b|| 1.411163207325e-01 >>>> > > > > 88 KSP preconditioned resid norm 2.217191418500e-07 true resid >>>> norm 7.465963600280e-08 ||r(i)||/||b|| 1.687787543128e-01 >>>> > > > > 89 KSP preconditioned resid norm 2.208527637102e-07 true resid >>>> norm 5.960066095409e-08 ||r(i)||/||b|| 1.347357936714e-01 >>>> > > > > 90 KSP preconditioned resid norm 2.204546869923e-07 true resid >>>> norm 6.334569716267e-08 ||r(i)||/||b|| 1.432019820964e-01 >>>> > > > > 91 KSP preconditioned resid norm 2.204546270123e-07 true resid >>>> norm 6.327475947831e-08 ||r(i)||/||b|| 1.430416173445e-01 >>>> > > > > 92 KSP preconditioned resid norm 2.204329606031e-07 true resid >>>> norm 6.775206679705e-08 ||r(i)||/||b|| 1.531632090424e-01 >>>> > > > > 93 KSP preconditioned resid norm 2.203318409249e-07 true resid >>>> norm 6.059983893344e-08 ||r(i)||/||b|| 1.369945779854e-01 >>>> > > > > 94 KSP preconditioned resid norm 2.202099673600e-07 true resid >>>> norm 7.148771248833e-08 ||r(i)||/||b|| 1.616081688639e-01 >>>> > > > > 95 KSP preconditioned resid norm 2.200347850341e-07 true resid >>>> norm 6.555792528003e-08 ||r(i)||/||b|| 1.482030392391e-01 >>>> > > > > 96 KSP preconditioned resid norm 2.196138742262e-07 true resid >>>> norm 6.418387078605e-08 ||r(i)||/||b|| 1.450967931030e-01 >>>> > > > > 97 KSP preconditioned resid norm 2.193396877997e-07 true resid >>>> norm 7.242613574407e-08 ||r(i)||/||b|| 1.637296084610e-01 >>>> > > > > 98 KSP preconditioned resid norm 2.186895327006e-07 true resid >>>> norm 5.717301192712e-08 ||r(i)||/||b|| 1.292477468416e-01 >>>> > > > > 99 KSP preconditioned resid norm 2.183391464984e-07 true resid >>>> norm 6.921630451950e-08 ||r(i)||/||b|| 1.564733272273e-01 >>>> > > > > 100 KSP preconditioned resid norm 2.182400010423e-07 true resid >>>> norm 6.548314285564e-08 ||r(i)||/||b|| 1.480339829041e-01 >>>> > > > > 101 KSP preconditioned resid norm 2.177799012029e-07 true resid >>>> norm 6.272281990396e-08 ||r(i)||/||b|| 1.417938792252e-01 >>>> > > > > 102 KSP preconditioned resid norm 2.169682429176e-07 true resid >>>> norm 7.907535208604e-08 ||r(i)||/||b|| 1.787611102394e-01 >>>> > > > > 103 KSP preconditioned resid norm 2.164150347952e-07 true resid >>>> norm 5.949404986863e-08 ||r(i)||/||b|| 1.344947841090e-01 >>>> > > > > 104 KSP preconditioned resid norm 2.163293952130e-07 true resid >>>> norm 6.398348014122e-08 ||r(i)||/||b|| 1.446437814729e-01 >>>> > > > > 105 KSP preconditioned resid norm 2.160399869141e-07 true resid >>>> norm 6.102742478406e-08 ||r(i)||/||b|| 1.379611967782e-01 >>>> > > > > 106 KSP preconditioned resid norm 2.152042538469e-07 true resid >>>> norm 5.769020450098e-08 ||r(i)||/||b|| 1.304169344110e-01 >>>> > > > > 107 KSP preconditioned resid norm 2.150064693173e-07 true resid >>>> norm 6.321432589105e-08 ||r(i)||/||b|| 1.429049986022e-01 >>>> > > > > 108 KSP preconditioned resid norm 2.144289854705e-07 true resid >>>> norm 5.801860121360e-08 ||r(i)||/||b|| 1.311593220122e-01 >>>> > > > > 109 KSP preconditioned resid norm 2.131016574445e-07 true resid >>>> norm 5.968888809818e-08 ||r(i)||/||b|| 1.349352437126e-01 >>>> > > > > 110 KSP preconditioned resid norm 2.131016340852e-07 true resid >>>> norm 5.978688769843e-08 ||r(i)||/||b|| 1.351567857846e-01 >>>> > > > > 111 KSP preconditioned resid norm 2.128679373780e-07 true resid >>>> norm 7.339671126222e-08 ||r(i)||/||b|| 1.659237328325e-01 >>>> > > > > 112 KSP preconditioned resid norm 2.124763157021e-07 true resid >>>> norm 6.095583088857e-08 ||r(i)||/||b|| 1.377993485676e-01 >>>> > > > > 113 KSP preconditioned resid norm 2.114936950060e-07 true resid >>>> norm 7.680678889067e-08 ||r(i)||/||b|| 1.736326996190e-01 >>>> > > > > 114 KSP preconditioned resid norm 2.111409526125e-07 true resid >>>> norm 6.861513382847e-08 ||r(i)||/||b|| 1.551142951480e-01 >>>> > > > > 115 KSP preconditioned resid norm 2.104578242179e-07 true resid >>>> norm 6.666552557721e-08 ||r(i)||/||b|| 1.507069276645e-01 >>>> > > > > 116 KSP preconditioned resid norm 2.095794193794e-07 true resid >>>> norm 8.409379058143e-08 ||r(i)||/||b|| 1.901060061323e-01 >>>> > > > > 117 KSP preconditioned resid norm 2.088313732014e-07 true resid >>>> norm 6.461621062155e-08 ||r(i)||/||b|| 1.460741589567e-01 >>>> > > > > 118 KSP preconditioned resid norm 2.076780694200e-07 true resid >>>> norm 8.889797338722e-08 ||r(i)||/||b|| 2.009665464840e-01 >>>> > > > > 119 KSP preconditioned resid norm 2.059381548473e-07 true resid >>>> norm 7.343872609510e-08 ||r(i)||/||b|| 1.660187133539e-01 >>>> > > > > 120 KSP preconditioned resid norm 2.036694513953e-07 true resid >>>> norm 7.626153726963e-08 ||r(i)||/||b|| 1.724000805719e-01 >>>> > > > > 121 KSP preconditioned resid norm 2.036437947430e-07 true resid >>>> norm 7.403000216323e-08 ||r(i)||/||b|| 1.673553772271e-01 >>>> > > > > 122 KSP preconditioned resid norm 2.034858116471e-07 true resid >>>> norm 9.140544194375e-08 ||r(i)||/||b|| 2.066350367433e-01 >>>> > > > > 123 KSP preconditioned resid norm 2.013655754252e-07 true resid >>>> norm 4.519978376641e-08 ||r(i)||/||b|| 1.021805570954e-01 >>>> > > > > 124 KSP preconditioned resid norm 1.998009157253e-07 true resid >>>> norm 7.924252610751e-08 ||r(i)||/||b|| 1.791390309555e-01 >>>> > > > > 125 KSP preconditioned resid norm 1.978761477601e-07 true resid >>>> norm 6.193706028697e-08 ||r(i)||/||b|| 1.400175575547e-01 >>>> > > > > 126 KSP preconditioned resid norm 1.966003019512e-07 true resid >>>> norm 5.417132474463e-08 ||r(i)||/||b|| 1.224620048983e-01 >>>> > > > > 127 KSP preconditioned resid norm 1.957579266801e-07 true resid >>>> norm 7.621152479630e-08 ||r(i)||/||b|| 1.722870202437e-01 >>>> > > > > 128 KSP preconditioned resid norm 1.950451407619e-07 true resid >>>> norm 5.429984244536e-08 ||r(i)||/||b|| 1.227525374885e-01 >>>> > > > > 129 KSP preconditioned resid norm 1.948052418686e-07 true resid >>>> norm 6.458532086853e-08 ||r(i)||/||b|| 1.460043282648e-01 >>>> > > > > 130 KSP preconditioned resid norm 1.946142511609e-07 true resid >>>> norm 5.988337322193e-08 ||r(i)||/||b|| 1.353749050701e-01 >>>> > > > > 131 KSP preconditioned resid norm 1.942556458837e-07 true resid >>>> norm 5.860812144886e-08 ||r(i)||/||b|| 1.324920165748e-01 >>>> > > > > 132 KSP preconditioned resid norm 1.935241717066e-07 true resid >>>> norm 8.129956448465e-08 ||r(i)||/||b|| 1.837892595590e-01 >>>> > > > > 133 KSP preconditioned resid norm 1.924599958511e-07 true resid >>>> norm 5.461025246990e-08 ||r(i)||/||b|| 1.234542636162e-01 >>>> > > > > 134 KSP preconditioned resid norm 1.920525995377e-07 true resid >>>> norm 6.091841929726e-08 ||r(i)||/||b|| 1.377147743302e-01 >>>> > > > > 135 KSP preconditioned resid norm 1.912474104817e-07 true resid >>>> norm 6.146257286777e-08 ||r(i)||/||b|| 1.389449110775e-01 >>>> > > > > 136 KSP preconditioned resid norm 1.899112302838e-07 true resid >>>> norm 5.363752248243e-08 ||r(i)||/||b|| 1.212552687596e-01 >>>> > > > > 137 KSP preconditioned resid norm 1.871603374495e-07 true resid >>>> norm 1.033541760028e-07 ||r(i)||/||b|| 2.336468540796e-01 >>>> > > > > 138 KSP preconditioned resid norm 1.848601023477e-07 true resid >>>> norm 4.885699993060e-08 ||r(i)||/||b|| 1.104482157861e-01 >>>> > > > > 139 KSP preconditioned resid norm 1.827750189949e-07 true resid >>>> norm 8.191132589117e-08 ||r(i)||/||b|| 1.851722334610e-01 >>>> > > > > 140 KSP preconditioned resid norm 1.793562029798e-07 true resid >>>> norm 6.003412567942e-08 ||r(i)||/||b|| 1.357157024989e-01 >>>> > > > > 141 KSP preconditioned resid norm 1.762198590085e-07 true resid >>>> norm 5.955815320828e-08 ||r(i)||/||b|| 1.346396988500e-01 >>>> > > > > 142 KSP preconditioned resid norm 1.735812332311e-07 true resid >>>> norm 7.966870349397e-08 ||r(i)||/||b|| 1.801024657142e-01 >>>> > > > > 143 KSP preconditioned resid norm 1.688412385715e-07 true resid >>>> norm 5.688299429377e-08 ||r(i)||/||b|| 1.285921206223e-01 >>>> > > > > 144 KSP preconditioned resid norm 1.661476005287e-07 true resid >>>> norm 7.082505578352e-08 ||r(i)||/||b|| 1.601101388819e-01 >>>> > > > > 145 KSP preconditioned resid norm 1.610383377332e-07 true resid >>>> norm 5.920400760597e-08 ||r(i)||/||b|| 1.338391022117e-01 >>>> > > > > 146 KSP preconditioned resid norm 1.544803228895e-07 true resid >>>> norm 6.998127061136e-08 ||r(i)||/||b|| 1.582026421690e-01 >>>> > > > > 147 KSP preconditioned resid norm 1.526491664454e-07 true resid >>>> norm 5.645428190677e-08 ||r(i)||/||b|| 1.276229551333e-01 >>>> > > > > 148 KSP preconditioned resid norm 1.514873753547e-07 true resid >>>> norm 5.864109468824e-08 ||r(i)||/||b|| 1.325665572848e-01 >>>> > > > > 149 KSP preconditioned resid norm 1.504821676672e-07 true resid >>>> norm 6.213039985019e-08 ||r(i)||/||b|| 1.404546292093e-01 >>>> > > > > 150 KSP preconditioned resid norm 1.486089733443e-07 true resid >>>> norm 5.614398416742e-08 ||r(i)||/||b|| 1.269214828423e-01 >>>> > > > > 151 KSP preconditioned resid norm 1.485963531298e-07 true resid >>>> norm 5.477576327252e-08 ||r(i)||/||b|| 1.238284243888e-01 >>>> > > > > 152 KSP preconditioned resid norm 1.485376571004e-07 true resid >>>> norm 6.371560914841e-08 ||r(i)||/||b|| 1.440382208929e-01 >>>> > > > > 153 KSP preconditioned resid norm 1.474539380136e-07 true resid >>>> norm 3.640242097893e-08 ||r(i)||/||b|| 8.229286393207e-02 >>>> > > > > 154 KSP preconditioned resid norm 1.468139621410e-07 true resid >>>> norm 4.869307908912e-08 ||r(i)||/||b|| 1.100776493474e-01 >>>> > > > > 155 KSP preconditioned resid norm 1.460083083948e-07 true resid >>>> norm 4.630532787515e-08 ||r(i)||/||b|| 1.046797972136e-01 >>>> > > > > 156 KSP preconditioned resid norm 1.443569894841e-07 true resid >>>> norm 3.603261718441e-08 ||r(i)||/||b|| 8.145686971725e-02 >>>> > > > > 157 KSP preconditioned resid norm 1.423163427629e-07 true resid >>>> norm 6.442826410227e-08 ||r(i)||/||b|| 1.456492790470e-01 >>>> > > > > 158 KSP preconditioned resid norm 1.409955526676e-07 true resid >>>> norm 3.683864351150e-08 ||r(i)||/||b|| 8.327900717616e-02 >>>> > > > > 159 KSP preconditioned resid norm 1.392132231651e-07 true resid >>>> norm 6.633950516791e-08 ||r(i)||/||b|| 1.499699120359e-01 >>>> > > > > 160 KSP preconditioned resid norm 1.373585912794e-07 true resid >>>> norm 4.602835576127e-08 ||r(i)||/||b|| 1.040536622515e-01 >>>> > > > > 161 KSP preconditioned resid norm 1.358554686788e-07 true resid >>>> norm 4.404395475469e-08 ||r(i)||/||b|| 9.956764078290e-02 >>>> > > > > 162 KSP preconditioned resid norm 1.356117729059e-07 true resid >>>> norm 5.220262213455e-08 ||r(i)||/||b|| 1.180114718936e-01 >>>> > > > > 163 KSP preconditioned resid norm 1.345828776136e-07 true resid >>>> norm 4.364444677578e-08 ||r(i)||/||b|| 9.866449602318e-02 >>>> > > > > 164 KSP preconditioned resid norm 1.335743316358e-07 true resid >>>> norm 4.365564289163e-08 ||r(i)||/||b|| 9.868980643971e-02 >>>> > > > > 165 KSP preconditioned resid norm 1.335181864567e-07 true resid >>>> norm 4.195338231508e-08 ||r(i)||/||b|| 9.484160364891e-02 >>>> > > > > 166 KSP preconditioned resid norm 1.334081155239e-07 true resid >>>> norm 4.320705771627e-08 ||r(i)||/||b|| 9.767571567858e-02 >>>> > > > > 167 KSP preconditioned resid norm 1.330652717803e-07 true resid >>>> norm 4.671646276077e-08 ||r(i)||/||b|| 1.056092262541e-01 >>>> > > > > 168 KSP preconditioned resid norm 1.327117008156e-07 true resid >>>> norm 4.076640307294e-08 ||r(i)||/||b|| 9.215826779826e-02 >>>> > > > > 169 KSP preconditioned resid norm 1.323823831437e-07 true resid >>>> norm 4.609403230274e-08 ||r(i)||/||b|| 1.042021334396e-01 >>>> > > > > 170 KSP preconditioned resid norm 1.321738715249e-07 true resid >>>> norm 4.115763769210e-08 ||r(i)||/||b|| 9.304270944840e-02 >>>> > > > > 171 KSP preconditioned resid norm 1.317312129565e-07 true resid >>>> norm 4.587805680503e-08 ||r(i)||/||b|| 1.037138900270e-01 >>>> > > > > 172 KSP preconditioned resid norm 1.315622581976e-07 true resid >>>> norm 4.346795666887e-08 ||r(i)||/||b|| 9.826551496744e-02 >>>> > > > > 173 KSP preconditioned resid norm 1.313903001504e-07 true resid >>>> norm 4.268100404068e-08 ||r(i)||/||b|| 9.648649632497e-02 >>>> > > > > 174 KSP preconditioned resid norm 1.310657837357e-07 true resid >>>> norm 4.888365697755e-08 ||r(i)||/||b|| 1.105084778423e-01 >>>> > > > > 175 KSP preconditioned resid norm 1.308286004287e-07 true resid >>>> norm 4.218058360777e-08 ||r(i)||/||b|| 9.535522457196e-02 >>>> > > > > 176 KSP preconditioned resid norm 1.305438769953e-07 true resid >>>> norm 5.026215795117e-08 ||r(i)||/||b|| 1.136247758797e-01 >>>> > > > > 177 KSP preconditioned resid norm 1.303521375300e-07 true resid >>>> norm 4.518428840914e-08 ||r(i)||/||b|| 1.021455276305e-01 >>>> > > > > 178 KSP preconditioned resid norm 1.302430349652e-07 true resid >>>> norm 4.699834591242e-08 ||r(i)||/||b|| 1.062464633174e-01 >>>> > > > > 179 KSP preconditioned resid norm 1.299950133828e-07 true resid >>>> norm 4.780011567673e-08 ||r(i)||/||b|| 1.080589782091e-01 >>>> > > > > 180 KSP preconditioned resid norm 1.297967984970e-07 true resid >>>> norm 4.439369158202e-08 ||r(i)||/||b|| 1.003582707567e-01 >>>> > > > > 181 KSP preconditioned resid norm 1.297963590960e-07 true resid >>>> norm 4.419939374367e-08 ||r(i)||/||b|| 9.991903278447e-02 >>>> > > > > 182 KSP preconditioned resid norm 1.297926195884e-07 true resid >>>> norm 4.616612604888e-08 ||r(i)||/||b|| 1.043651116339e-01 >>>> > > > > 183 KSP preconditioned resid norm 1.297319003442e-07 true resid >>>> norm 3.981403448576e-08 ||r(i)||/||b|| 9.000530279069e-02 >>>> > > > > 184 KSP preconditioned resid norm 1.296224619385e-07 true resid >>>> norm 5.101974490162e-08 ||r(i)||/||b|| 1.153374092198e-01 >>>> > > > > 185 KSP preconditioned resid norm 1.294198893701e-07 true resid >>>> norm 4.272250450111e-08 ||r(i)||/||b|| 9.658031403412e-02 >>>> > > > > 186 KSP preconditioned resid norm 1.292654432794e-07 true resid >>>> norm 4.341411289813e-08 ||r(i)||/||b|| 9.814379344509e-02 >>>> > > > > 187 KSP preconditioned resid norm 1.291166048974e-07 true resid >>>> norm 4.903770559588e-08 ||r(i)||/||b|| 1.108567267127e-01 >>>> > > > > 188 KSP preconditioned resid norm 1.287267461311e-07 true resid >>>> norm 3.838768901036e-08 ||r(i)||/||b|| 8.678084543401e-02 >>>> > > > > 189 KSP preconditioned resid norm 1.285403517589e-07 true resid >>>> norm 4.836219780019e-08 ||r(i)||/||b|| 1.093296450071e-01 >>>> > > > > 190 KSP preconditioned resid norm 1.283960766544e-07 true resid >>>> norm 4.373642319734e-08 ||r(i)||/||b|| 9.887242184076e-02 >>>> > > > > 191 KSP preconditioned resid norm 1.281846985469e-07 true resid >>>> norm 4.196631979171e-08 ||r(i)||/||b|| 9.487085065985e-02 >>>> > > > > 192 KSP preconditioned resid norm 1.279291087436e-07 true resid >>>> norm 5.017898447715e-08 ||r(i)||/||b|| 1.134367503804e-01 >>>> > > > > 193 KSP preconditioned resid norm 1.277583114588e-07 true resid >>>> norm 4.217096345089e-08 ||r(i)||/||b|| 9.533347683541e-02 >>>> > > > > 194 KSP preconditioned resid norm 1.275868702813e-07 true resid >>>> norm 4.784228026600e-08 ||r(i)||/||b|| 1.081542972762e-01 >>>> > > > > 195 KSP preconditioned resid norm 1.273992295764e-07 true resid >>>> norm 4.379242155010e-08 ||r(i)||/||b|| 9.899901410304e-02 >>>> > > > > 196 KSP preconditioned resid norm 1.272302392639e-07 true resid >>>> norm 4.236252438739e-08 ||r(i)||/||b|| 9.576652765067e-02 >>>> > > > > 197 KSP preconditioned resid norm 1.269756464572e-07 true resid >>>> norm 5.265147070813e-08 ||r(i)||/||b|| 1.190261581040e-01 >>>> > > > > 198 KSP preconditioned resid norm 1.266399406059e-07 true resid >>>> norm 3.658633711709e-08 ||r(i)||/||b|| 8.270863259045e-02 >>>> > > > > 199 KSP preconditioned resid norm 1.262216614405e-07 true resid >>>> norm 4.823243517156e-08 ||r(i)||/||b|| 1.090362980798e-01 >>>> > > > > 200 KSP preconditioned resid norm 1.256037114182e-07 true resid >>>> norm 4.118749777942e-08 ||r(i)||/||b|| 9.311021243410e-02 >>>> > > > > 201 KSP preconditioned resid norm 1.252357182659e-07 true resid >>>> norm 4.297385591425e-08 ||r(i)||/||b|| 9.714852974845e-02 >>>> > > > > 202 KSP preconditioned resid norm 1.242188985573e-07 true resid >>>> norm 4.735199275670e-08 ||r(i)||/||b|| 1.070459324421e-01 >>>> > > > > 203 KSP preconditioned resid norm 1.231408970960e-07 true resid >>>> norm 3.893514112125e-08 ||r(i)||/||b|| 8.801843900221e-02 >>>> > > > > 204 KSP preconditioned resid norm 1.220276184666e-07 true resid >>>> norm 4.828090901382e-08 ||r(i)||/||b|| 1.091458801130e-01 >>>> > > > > 205 KSP preconditioned resid norm 1.200057581901e-07 true resid >>>> norm 3.901824500784e-08 ||r(i)||/||b|| 8.820630718920e-02 >>>> > > > > 206 KSP preconditioned resid norm 1.190463271301e-07 true resid >>>> norm 3.812404409291e-08 ||r(i)||/||b|| 8.618483850000e-02 >>>> > > > > 207 KSP preconditioned resid norm 1.176408472739e-07 true resid >>>> norm 4.100938913911e-08 ||r(i)||/||b|| 9.270757245280e-02 >>>> > > > > 208 KSP preconditioned resid norm 1.166353857162e-07 true resid >>>> norm 3.610482888020e-08 ||r(i)||/||b|| 8.162011455361e-02 >>>> > > > > 209 KSP preconditioned resid norm 1.159620049487e-07 true resid >>>> norm 3.566307135323e-08 ||r(i)||/||b|| 8.062145866534e-02 >>>> > > > > 210 KSP preconditioned resid norm 1.146020921987e-07 true resid >>>> norm 3.592344723620e-08 ||r(i)||/||b|| 8.121007548070e-02 >>>> > > > > 211 KSP preconditioned resid norm 1.145847448331e-07 true resid >>>> norm 3.473565983922e-08 ||r(i)||/||b|| 7.852491268077e-02 >>>> > > > > 212 KSP preconditioned resid norm 1.145177079586e-07 true resid >>>> norm 4.122532839361e-08 ||r(i)||/||b|| 9.319573393247e-02 >>>> > > > > 213 KSP preconditioned resid norm 1.132872800274e-07 true resid >>>> norm 2.141692237998e-08 ||r(i)||/||b|| 4.841600728366e-02 >>>> > > > > 214 KSP preconditioned resid norm 1.123613362087e-07 true resid >>>> norm 3.246863698820e-08 ||r(i)||/||b|| 7.339998422842e-02 >>>> > > > > 215 KSP preconditioned resid norm 1.111053137881e-07 true resid >>>> norm 2.903254997529e-08 ||r(i)||/||b|| 6.563221951914e-02 >>>> > > > > 216 KSP preconditioned resid norm 1.099813982910e-07 true resid >>>> norm 2.173780265025e-08 ||r(i)||/||b|| 4.914140289501e-02 >>>> > > > > 217 KSP preconditioned resid norm 1.089711486676e-07 true resid >>>> norm 4.266914180936e-08 ||r(i)||/||b|| 9.645968005942e-02 >>>> > > > > 218 KSP preconditioned resid norm 1.077041044884e-07 true resid >>>> norm 2.174207697189e-08 ||r(i)||/||b|| 4.915106560862e-02 >>>> > > > > 219 KSP preconditioned resid norm 1.068087285500e-07 true resid >>>> norm 3.726239717827e-08 ||r(i)||/||b|| 8.423696277093e-02 >>>> > > > > 220 KSP preconditioned resid norm 1.060944039406e-07 true resid >>>> norm 2.612138847397e-08 ||r(i)||/||b|| 5.905112378786e-02 >>>> > > > > 221 KSP preconditioned resid norm 1.052145789908e-07 true resid >>>> norm 2.848574746885e-08 ||r(i)||/||b|| 6.439609447443e-02 >>>> > > > > 222 KSP preconditioned resid norm 1.034013372786e-07 true resid >>>> norm 4.496176952774e-08 ||r(i)||/||b|| 1.016424919659e-01 >>>> > > > > 223 KSP preconditioned resid norm 1.016447882738e-07 true resid >>>> norm 2.629128290689e-08 ||r(i)||/||b|| 5.943519438194e-02 >>>> > > > > 224 KSP preconditioned resid norm 1.002724751991e-07 true resid >>>> norm 3.297488178025e-08 ||r(i)||/||b|| 7.454442277585e-02 >>>> > > > > 225 KSP preconditioned resid norm 9.969279422176e-08 true resid >>>> norm 3.069952269998e-08 ||r(i)||/||b|| 6.940064908846e-02 >>>> > > > > 226 KSP preconditioned resid norm 9.811249548568e-08 true resid >>>> norm 3.219822477037e-08 ||r(i)||/||b|| 7.278867884683e-02 >>>> > > > > 227 KSP preconditioned resid norm 9.637808562080e-08 true resid >>>> norm 4.091298315961e-08 ||r(i)||/||b|| 9.248963298779e-02 >>>> > > > > 228 KSP preconditioned resid norm 9.526012021860e-08 true resid >>>> norm 2.720466192827e-08 ||r(i)||/||b|| 6.150001791574e-02 >>>> > > > > 229 KSP preconditioned resid norm 9.392714618074e-08 true resid >>>> norm 4.018517470597e-08 ||r(i)||/||b|| 9.084431818639e-02 >>>> > > > > 230 KSP preconditioned resid norm 9.288540879331e-08 true resid >>>> norm 2.742429822661e-08 ||r(i)||/||b|| 6.199653709024e-02 >>>> > > > > 231 KSP preconditioned resid norm 9.182683719708e-08 true resid >>>> norm 3.418196050419e-08 ||r(i)||/||b|| 7.727319637148e-02 >>>> > > > > 232 KSP preconditioned resid norm 9.152618596319e-08 true resid >>>> norm 3.061702948039e-08 ||r(i)||/||b|| 6.921416140130e-02 >>>> > > > > 233 KSP preconditioned resid norm 9.028012081487e-08 true resid >>>> norm 3.309940751576e-08 ||r(i)||/||b|| 7.482593095946e-02 >>>> > > > > 234 KSP preconditioned resid norm 8.964512632411e-08 true resid >>>> norm 3.657895201743e-08 ||r(i)||/||b|| 8.269193751948e-02 >>>> > > > > 235 KSP preconditioned resid norm 8.927591956786e-08 true resid >>>> norm 2.996402299113e-08 ||r(i)||/||b|| 6.773794710778e-02 >>>> > > > > 236 KSP preconditioned resid norm 8.863790942206e-08 true resid >>>> norm 3.770401488950e-08 ||r(i)||/||b|| 8.523530258577e-02 >>>> > > > > 237 KSP preconditioned resid norm 8.842416675824e-08 true resid >>>> norm 3.294247881070e-08 ||r(i)||/||b|| 7.447117124223e-02 >>>> > > > > 238 KSP preconditioned resid norm 8.793063593991e-08 true resid >>>> norm 3.836231748404e-08 ||r(i)||/||b|| 8.672348948056e-02 >>>> > > > > 239 KSP preconditioned resid norm 8.778266322588e-08 true resid >>>> norm 3.572179823322e-08 ||r(i)||/||b|| 8.075421915252e-02 >>>> > > > > 240 KSP preconditioned resid norm 8.738590572964e-08 true resid >>>> norm 3.574931934089e-08 ||r(i)||/||b|| 8.081643454117e-02 >>>> > > > > 241 KSP preconditioned resid norm 8.738404146064e-08 true resid >>>> norm 3.532576961772e-08 ||r(i)||/||b|| 7.985893998998e-02 >>>> > > > > 242 KSP preconditioned resid norm 8.737492315747e-08 true resid >>>> norm 3.850858638399e-08 ||r(i)||/||b|| 8.705415118814e-02 >>>> > > > > 243 KSP preconditioned resid norm 8.704894133677e-08 true resid >>>> norm 2.725999899728e-08 ||r(i)||/||b|| 6.162511525180e-02 >>>> > > > > 244 KSP preconditioned resid norm 8.691957267756e-08 true resid >>>> norm 3.445507385918e-08 ||r(i)||/||b|| 7.789060805883e-02 >>>> > > > > 245 KSP preconditioned resid norm 8.664547872292e-08 true resid >>>> norm 3.233777274784e-08 ||r(i)||/||b|| 7.310414695067e-02 >>>> > > > > 246 KSP preconditioned resid norm 8.647910251595e-08 true resid >>>> norm 2.869258593620e-08 ||r(i)||/||b|| 6.486368232688e-02 >>>> > > > > 247 KSP preconditioned resid norm 8.602870326813e-08 true resid >>>> norm 3.830342792446e-08 ||r(i)||/||b|| 8.659036123294e-02 >>>> > > > > 248 KSP preconditioned resid norm 8.584186792773e-08 true resid >>>> norm 2.914852049114e-08 ||r(i)||/||b|| 6.589438740865e-02 >>>> > > > > 249 KSP preconditioned resid norm 8.568202493555e-08 true resid >>>> norm 3.726679821110e-08 ||r(i)||/||b|| 8.424691193326e-02 >>>> > > > > 250 KSP preconditioned resid norm 8.535775976392e-08 true resid >>>> norm 3.374879488937e-08 ||r(i)||/||b|| 7.629396372591e-02 >>>> > > > > 251 KSP preconditioned resid norm 8.505569181999e-08 true resid >>>> norm 3.019219829750e-08 ||r(i)||/||b|| 6.825376992767e-02 >>>> > > > > 252 KSP preconditioned resid norm 8.489565939881e-08 true resid >>>> norm 3.532505625863e-08 ||r(i)||/||b|| 7.985732734003e-02 >>>> > > > > 253 KSP preconditioned resid norm 8.454497959931e-08 true resid >>>> norm 2.833135878246e-08 ||r(i)||/||b|| 6.404707683166e-02 >>>> > > > > 254 KSP preconditioned resid norm 8.448142425824e-08 true resid >>>> norm 3.023601426215e-08 ||r(i)||/||b|| 6.835282216432e-02 >>>> > > > > 255 KSP preconditioned resid norm 8.447314709431e-08 true resid >>>> norm 2.955565650261e-08 ||r(i)||/||b|| 6.681477642380e-02 >>>> > > > > 256 KSP preconditioned resid norm 8.434191340398e-08 true resid >>>> norm 3.011718192322e-08 ||r(i)||/||b|| 6.808418471561e-02 >>>> > > > > 257 KSP preconditioned resid norm 8.420519688672e-08 true resid >>>> norm 3.194610164662e-08 ||r(i)||/||b|| 7.221871857057e-02 >>>> > > > > 258 KSP preconditioned resid norm 8.414920999588e-08 true resid >>>> norm 2.927199782498e-08 ||r(i)||/||b|| 6.617352553076e-02 >>>> > > > > 259 KSP preconditioned resid norm 8.411142889741e-08 true resid >>>> norm 3.116811073402e-08 ||r(i)||/||b|| 7.045995916421e-02 >>>> > > > > 260 KSP preconditioned resid norm 8.393401673483e-08 true resid >>>> norm 2.913633916610e-08 ||r(i)||/||b|| 6.586684978622e-02 >>>> > > > > 261 KSP preconditioned resid norm 8.386932870420e-08 true resid >>>> norm 2.931516814567e-08 ||r(i)||/||b|| 6.627111819715e-02 >>>> > > > > 262 KSP preconditioned resid norm 8.383102906154e-08 true resid >>>> norm 2.947670084156e-08 ||r(i)||/||b|| 6.663628589221e-02 >>>> > > > > 263 KSP preconditioned resid norm 8.371299202072e-08 true resid >>>> norm 2.900846382950e-08 ||r(i)||/||b|| 6.557776935168e-02 >>>> > > > > 264 KSP preconditioned resid norm 8.354612585259e-08 true resid >>>> norm 3.153902284033e-08 ||r(i)||/||b|| 7.129845887590e-02 >>>> > > > > 265 KSP preconditioned resid norm 8.348749379055e-08 true resid >>>> norm 2.912311287048e-08 ||r(i)||/||b|| 6.583694985881e-02 >>>> > > > > 266 KSP preconditioned resid norm 8.328479663117e-08 true resid >>>> norm 3.201390360666e-08 ||r(i)||/||b|| 7.237199457042e-02 >>>> > > > > 267 KSP preconditioned resid norm 8.304748250656e-08 true resid >>>> norm 3.103708076427e-08 ||r(i)||/||b|| 7.016374723157e-02 >>>> > > > > 268 KSP preconditioned resid norm 8.294564373794e-08 true resid >>>> norm 2.975578688471e-08 ||r(i)||/||b|| 6.726719969290e-02 >>>> > > > > 269 KSP preconditioned resid norm 8.286083099532e-08 true resid >>>> norm 3.122272154943e-08 ||r(i)||/||b|| 7.058341470044e-02 >>>> > > > > 270 KSP preconditioned resid norm 8.249515525349e-08 true resid >>>> norm 2.958445476571e-08 ||r(i)||/||b|| 6.687987900443e-02 >>>> > > > > 271 KSP preconditioned resid norm 8.249243482197e-08 true resid >>>> norm 2.915759140675e-08 ||r(i)||/||b|| 6.591489350698e-02 >>>> > > > > 272 KSP preconditioned resid norm 8.247967811026e-08 true resid >>>> norm 3.226477388325e-08 ||r(i)||/||b|| 7.293912260697e-02 >>>> > > > > 273 KSP preconditioned resid norm 8.225540420138e-08 true resid >>>> norm 2.335784346654e-08 ||r(i)||/||b|| 5.280373619246e-02 >>>> > > > > 274 KSP preconditioned resid norm 8.208649428128e-08 true resid >>>> norm 3.103095297226e-08 ||r(i)||/||b|| 7.014989448385e-02 >>>> > > > > 275 KSP preconditioned resid norm 8.177662092059e-08 true resid >>>> norm 2.780330970969e-08 ||r(i)||/||b|| 6.285334659815e-02 >>>> > > > > 276 KSP preconditioned resid norm 8.156719698267e-08 true resid >>>> norm 2.529092246235e-08 ||r(i)||/||b|| 5.717373693676e-02 >>>> > > > > 277 KSP preconditioned resid norm 8.129665601936e-08 true resid >>>> norm 3.216359520748e-08 ||r(i)||/||b|| 7.271039378141e-02 >>>> > > > > 278 KSP preconditioned resid norm 8.111942990953e-08 true resid >>>> norm 2.578429842977e-08 ||r(i)||/||b|| 5.828908367091e-02 >>>> > > > > 279 KSP preconditioned resid norm 8.103355449576e-08 true resid >>>> norm 3.114448259432e-08 ||r(i)||/||b|| 7.040654438485e-02 >>>> > > > > 280 KSP preconditioned resid norm 8.096927476093e-08 true resid >>>> norm 2.905799246198e-08 ||r(i)||/||b|| 6.568973588864e-02 >>>> > > > > 281 KSP preconditioned resid norm 8.069018681340e-08 true resid >>>> norm 2.806750078967e-08 ||r(i)||/||b|| 6.345058821044e-02 >>>> > > > > 282 KSP preconditioned resid norm 8.047055052412e-08 true resid >>>> norm 3.356282539492e-08 ||r(i)||/||b|| 7.587355316280e-02 >>>> > > > > 283 KSP preconditioned resid norm 8.023864541552e-08 true resid >>>> norm 2.697346140135e-08 ||r(i)||/||b|| 6.097735615340e-02 >>>> > > > > 284 KSP preconditioned resid norm 8.014006658762e-08 true resid >>>> norm 3.033393715647e-08 ||r(i)||/||b|| 6.857419083160e-02 >>>> > > > > 285 KSP preconditioned resid norm 8.000866139550e-08 true resid >>>> norm 2.744969989335e-08 ||r(i)||/||b|| 6.205396118040e-02 >>>> > > > > 286 KSP preconditioned resid norm 7.963315124505e-08 true resid >>>> norm 2.853888338671e-08 ||r(i)||/||b|| 6.451621579442e-02 >>>> > > > > 287 KSP preconditioned resid norm 7.901906690217e-08 true resid >>>> norm 3.213929486191e-08 ||r(i)||/||b|| 7.265545938481e-02 >>>> > > > > 288 KSP preconditioned resid norm 7.847487693433e-08 true resid >>>> norm 2.531887675170e-08 ||r(i)||/||b|| 5.723693159436e-02 >>>> > > > > 289 KSP preconditioned resid norm 7.776109704697e-08 true resid >>>> norm 3.151424977919e-08 ||r(i)||/||b|| 7.124245583834e-02 >>>> > > > > 290 KSP preconditioned resid norm 7.697887176101e-08 true resid >>>> norm 2.452083040958e-08 ||r(i)||/||b|| 5.543283402950e-02 >>>> > > > > 291 KSP preconditioned resid norm 7.630186207736e-08 true resid >>>> norm 2.646550673478e-08 ||r(i)||/||b|| 5.982905219075e-02 >>>> > > > > 292 KSP preconditioned resid norm 7.539569101676e-08 true resid >>>> norm 2.639665425804e-08 ||r(i)||/||b|| 5.967340134812e-02 >>>> > > > > 293 KSP preconditioned resid norm 7.387540581378e-08 true resid >>>> norm 2.766591414879e-08 ||r(i)||/||b|| 6.254274433891e-02 >>>> > > > > 294 KSP preconditioned resid norm 7.148854762848e-08 true resid >>>> norm 4.506538736910e-08 ||r(i)||/||b|| 1.018767348732e-01 >>>> > > > > 295 KSP preconditioned resid norm 6.875818761377e-08 true resid >>>> norm 1.988285545247e-08 ||r(i)||/||b|| 4.494803022244e-02 >>>> > > > > 296 KSP preconditioned resid norm 6.720148343751e-08 true resid >>>> norm 2.185917455369e-08 ||r(i)||/||b|| 4.941578139143e-02 >>>> > > > > 297 KSP preconditioned resid norm 6.559210493364e-08 true resid >>>> norm 2.579380002545e-08 ||r(i)||/||b|| 5.831056338297e-02 >>>> > > > > 298 KSP preconditioned resid norm 6.296172453909e-08 true resid >>>> norm 2.690729261887e-08 ||r(i)||/||b|| 6.082777218435e-02 >>>> > > > > 299 KSP preconditioned resid norm 6.126664666716e-08 true resid >>>> norm 2.523269850506e-08 ||r(i)||/||b|| 5.704211337804e-02 >>>> > > > > 300 KSP preconditioned resid norm 5.996078539496e-08 true resid >>>> norm 1.432165407581e-08 ||r(i)||/||b|| 3.237614143370e-02 >>>> > > > > 301 KSP preconditioned resid norm 5.994360410331e-08 true resid >>>> norm 1.354971586959e-08 ||r(i)||/||b|| 3.063106503328e-02 >>>> > > > > 302 KSP preconditioned resid norm 5.968927298570e-08 true resid >>>> norm 2.119292714347e-08 ||r(i)||/||b|| 4.790963410783e-02 >>>> > > > > 303 KSP preconditioned resid norm 5.871687993468e-08 true resid >>>> norm 8.809042798461e-09 ||r(i)||/||b|| 1.991409749382e-02 >>>> > > > > 304 KSP preconditioned resid norm 5.799650512507e-08 true resid >>>> norm 1.745679956812e-08 ||r(i)||/||b|| 3.946358491871e-02 >>>> > > > > 305 KSP preconditioned resid norm 5.745928074883e-08 true resid >>>> norm 1.274997712124e-08 ||r(i)||/||b|| 2.882314154277e-02 >>>> > > > > 306 KSP preconditioned resid norm 5.632393272566e-08 true resid >>>> norm 1.202295750268e-08 ||r(i)||/||b|| 2.717961001553e-02 >>>> > > > > 307 KSP preconditioned resid norm 5.396643228430e-08 true resid >>>> norm 2.502414535309e-08 ||r(i)||/||b|| 5.657064923649e-02 >>>> > > > > 308 KSP preconditioned resid norm 5.160090231555e-08 true resid >>>> norm 1.262817440249e-08 ||r(i)||/||b|| 2.854778912689e-02 >>>> > > > > 309 KSP preconditioned resid norm 4.907022431548e-08 true resid >>>> norm 2.171207321606e-08 ||r(i)||/||b|| 4.908323783977e-02 >>>> > > > > 310 KSP preconditioned resid norm 4.776335659862e-08 true resid >>>> norm 1.151540470517e-08 ||r(i)||/||b|| 2.603221453522e-02 >>>> > > > > 311 KSP preconditioned resid norm 4.697621190386e-08 true resid >>>> norm 1.508650195148e-08 ||r(i)||/||b|| 3.410518913076e-02 >>>> > > > > 312 KSP preconditioned resid norm 4.595176479120e-08 true resid >>>> norm 1.933671761706e-08 ||r(i)||/||b|| 4.371340776138e-02 >>>> > > > > 313 KSP preconditioned resid norm 4.509046368009e-08 true resid >>>> norm 1.186794873424e-08 ||r(i)||/||b|| 2.682919058886e-02 >>>> > > > > 314 KSP preconditioned resid norm 4.450909170016e-08 true resid >>>> norm 1.579009874879e-08 ||r(i)||/||b|| 3.569577003024e-02 >>>> > > > > 315 KSP preconditioned resid norm 4.337869810365e-08 true resid >>>> norm 1.647588479037e-08 ||r(i)||/||b|| 3.724608717643e-02 >>>> > > > > 316 KSP preconditioned resid norm 4.223810751226e-08 true resid >>>> norm 1.498137614524e-08 ||r(i)||/||b|| 3.386753725389e-02 >>>> > > > > 317 KSP preconditioned resid norm 4.156026722749e-08 true resid >>>> norm 1.333299778266e-08 ||r(i)||/||b|| 3.014114289185e-02 >>>> > > > > 318 KSP preconditioned resid norm 4.099199515842e-08 true resid >>>> norm 1.310678580056e-08 ||r(i)||/||b|| 2.962975844646e-02 >>>> > > > > 319 KSP preconditioned resid norm 4.066386009421e-08 true resid >>>> norm 1.506644976724e-08 ||r(i)||/||b|| 3.405985830867e-02 >>>> > > > > 320 KSP preconditioned resid norm 4.023087548652e-08 true resid >>>> norm 1.240117063260e-08 ||r(i)||/||b|| 2.803461473228e-02 >>>> > > > > 321 KSP preconditioned resid norm 3.991268177919e-08 true resid >>>> norm 1.312932289209e-08 ||r(i)||/||b|| 2.968070675585e-02 >>>> > > > > 322 KSP preconditioned resid norm 3.956889976017e-08 true resid >>>> norm 1.421972275585e-08 ||r(i)||/||b|| 3.214571114861e-02 >>>> > > > > 323 KSP preconditioned resid norm 3.900185975518e-08 true resid >>>> norm 1.347489145169e-08 ||r(i)||/||b|| 3.046191376598e-02 >>>> > > > > 324 KSP preconditioned resid norm 3.877682049038e-08 true resid >>>> norm 1.279539901604e-08 ||r(i)||/||b|| 2.892582421352e-02 >>>> > > > > 325 KSP preconditioned resid norm 3.869150965109e-08 true resid >>>> norm 1.224801722014e-08 ||r(i)||/||b|| 2.768838960238e-02 >>>> > > > > 326 KSP preconditioned resid norm 3.851624335552e-08 true resid >>>> norm 1.309261686557e-08 ||r(i)||/||b|| 2.959772754831e-02 >>>> > > > > 327 KSP preconditioned resid norm 3.836778709819e-08 true resid >>>> norm 1.256963552910e-08 ||r(i)||/||b|| 2.841545365542e-02 >>>> > > > > 328 KSP preconditioned resid norm 3.810190892142e-08 true resid >>>> norm 1.532295260746e-08 ||r(i)||/||b|| 3.463971955858e-02 >>>> > > > > 329 KSP preconditioned resid norm 3.779873511822e-08 true resid >>>> norm 1.357026597966e-08 ||r(i)||/||b|| 3.067752148771e-02 >>>> > > > > 330 KSP preconditioned resid norm 3.758209190896e-08 true resid >>>> norm 1.326727470061e-08 ||r(i)||/||b|| 2.999256649217e-02 >>>> > > > > 331 KSP preconditioned resid norm 3.758046617049e-08 true resid >>>> norm 1.304204653926e-08 ||r(i)||/||b|| 2.948340611389e-02 >>>> > > > > 332 KSP preconditioned resid norm 3.756576997625e-08 true resid >>>> norm 1.547320887283e-08 ||r(i)||/||b|| 3.497939527431e-02 >>>> > > > > 333 KSP preconditioned resid norm 3.735750946435e-08 true resid >>>> norm 9.401475437163e-09 ||r(i)||/||b|| 2.125337595977e-02 >>>> > > > > 334 KSP preconditioned resid norm 3.726816411327e-08 true resid >>>> norm 1.293737018744e-08 ||r(i)||/||b|| 2.924677029283e-02 >>>> > > > > 335 KSP preconditioned resid norm 3.715836120670e-08 true resid >>>> norm 1.137076112403e-08 ||r(i)||/||b|| 2.570522709260e-02 >>>> > > > > 336 KSP preconditioned resid norm 3.711352115906e-08 true resid >>>> norm 1.100868545692e-08 ||r(i)||/||b|| 2.488670341188e-02 >>>> > > > > 337 KSP preconditioned resid norm 3.697154209112e-08 true resid >>>> norm 1.292178506561e-08 ||r(i)||/||b|| 2.921153790237e-02 >>>> > > > > 338 KSP preconditioned resid norm 3.687250442553e-08 true resid >>>> norm 1.038256633339e-08 ||r(i)||/||b|| 2.347127184298e-02 >>>> > > > > 339 KSP preconditioned resid norm 3.681163672322e-08 true resid >>>> norm 1.217819776625e-08 ||r(i)||/||b|| 2.753055276999e-02 >>>> > > > > 340 KSP preconditioned resid norm 3.676709918842e-08 true resid >>>> norm 1.163124964184e-08 ||r(i)||/||b|| 2.629409853509e-02 >>>> > > > > 341 KSP preconditioned resid norm 3.664698023565e-08 true resid >>>> norm 1.141439938468e-08 ||r(i)||/||b|| 2.580387760401e-02 >>>> > > > > 342 KSP preconditioned resid norm 3.656190729093e-08 true resid >>>> norm 1.232477473873e-08 ||r(i)||/||b|| 2.786191091946e-02 >>>> > > > > 343 KSP preconditioned resid norm 3.650243259584e-08 true resid >>>> norm 1.132768943490e-08 ||r(i)||/||b|| 2.560785739692e-02 >>>> > > > > 344 KSP preconditioned resid norm 3.650130795451e-08 true resid >>>> norm 1.141084292815e-08 ||r(i)||/||b|| 2.579583772683e-02 >>>> > > > > 345 KSP preconditioned resid norm 3.647229125147e-08 true resid >>>> norm 1.138306478808e-08 ||r(i)||/||b|| 2.573304127980e-02 >>>> > > > > 346 KSP preconditioned resid norm 3.643856164392e-08 true resid >>>> norm 1.116515940173e-08 ||r(i)||/||b|| 2.524043507871e-02 >>>> > > > > 347 KSP preconditioned resid norm 3.639892567434e-08 true resid >>>> norm 1.174359887576e-08 ||r(i)||/||b|| 2.654808000036e-02 >>>> > > > > 348 KSP preconditioned resid norm 3.632894120883e-08 true resid >>>> norm 1.064588448828e-08 ||r(i)||/||b|| 2.406654008362e-02 >>>> > > > > 349 KSP preconditioned resid norm 3.632109543324e-08 true resid >>>> norm 1.070526312693e-08 ||r(i)||/||b|| 2.420077396422e-02 >>>> > > > > 350 KSP preconditioned resid norm 3.628173432975e-08 true resid >>>> norm 1.071879321292e-08 ||r(i)||/||b|| 2.423136065311e-02 >>>> > > > > 351 KSP preconditioned resid norm 3.621714360676e-08 true resid >>>> norm 1.066953807038e-08 ||r(i)||/||b|| 2.412001237918e-02 >>>> > > > > 352 KSP preconditioned resid norm 3.614598721323e-08 true resid >>>> norm 1.067226627219e-08 ||r(i)||/||b|| 2.412617986843e-02 >>>> > > > > 353 KSP preconditioned resid norm 3.608734513646e-08 true resid >>>> norm 1.072773727635e-08 ||r(i)||/||b|| 2.425157998401e-02 >>>> > > > > 354 KSP preconditioned resid norm 3.593202477726e-08 true resid >>>> norm 1.166649044369e-08 ||r(i)||/||b|| 2.637376539332e-02 >>>> > > > > 355 KSP preconditioned resid norm 3.574816645908e-08 true resid >>>> norm 1.093827518487e-08 ||r(i)||/||b|| 2.472753095079e-02 >>>> > > > > 356 KSP preconditioned resid norm 3.551731486762e-08 true resid >>>> norm 1.076438469683e-08 ||r(i)||/||b|| 2.433442670423e-02 >>>> > > > > 357 KSP preconditioned resid norm 3.526513581484e-08 true resid >>>> norm 1.110249798589e-08 ||r(i)||/||b|| 2.509878001212e-02 >>>> > > > > 358 KSP preconditioned resid norm 3.465142744209e-08 true resid >>>> norm 1.363275954561e-08 ||r(i)||/||b|| 3.081879710568e-02 >>>> > > > > 359 KSP preconditioned resid norm 3.445104570595e-08 true resid >>>> norm 1.002161340638e-08 ||r(i)||/||b|| 2.265528627639e-02 >>>> > > > > 360 KSP preconditioned resid norm 3.412299596043e-08 true resid >>>> norm 1.132489003434e-08 ||r(i)||/||b|| 2.560152895272e-02 >>>> > > > > 361 KSP preconditioned resid norm 3.411529696237e-08 true resid >>>> norm 1.086147186780e-08 ||r(i)||/||b|| 2.455390609972e-02 >>>> > > > > 362 KSP preconditioned resid norm 3.406577468016e-08 true resid >>>> norm 1.456732293497e-08 ||r(i)||/||b|| 3.293151092439e-02 >>>> > > > > 363 KSP preconditioned resid norm 3.365555787056e-08 true resid >>>> norm 7.711588827294e-09 ||r(i)||/||b|| 1.743314628529e-02 >>>> > > > > 364 KSP preconditioned resid norm 3.345269937851e-08 true resid >>>> norm 1.136806437719e-08 ||r(i)||/||b|| 2.569913071178e-02 >>>> > > > > 365 KSP preconditioned resid norm 3.314065779377e-08 true resid >>>> norm 9.636397417285e-09 ||r(i)||/||b|| 2.178445059780e-02 >>>> > > > > 366 KSP preconditioned resid norm 3.276476852537e-08 true resid >>>> norm 8.198503499564e-09 ||r(i)||/||b|| 1.853388634033e-02 >>>> > > > > 367 KSP preconditioned resid norm 3.259579551722e-08 true resid >>>> norm 1.047105927610e-08 ||r(i)||/||b|| 2.367132275987e-02 >>>> > > > > 368 KSP preconditioned resid norm 3.250921252208e-08 true resid >>>> norm 8.145570438537e-09 ||r(i)||/||b|| 1.841422360715e-02 >>>> > > > > 369 KSP preconditioned resid norm 3.241361225044e-08 true resid >>>> norm 1.107380056199e-08 ||r(i)||/||b|| 2.503390539290e-02 >>>> > > > > 370 KSP preconditioned resid norm 3.226640160009e-08 true resid >>>> norm 8.914996078156e-09 ||r(i)||/||b|| 2.015361999245e-02 >>>> > > > > 371 KSP preconditioned resid norm 3.219199485113e-08 true resid >>>> norm 9.028612338383e-09 ||r(i)||/||b|| 2.041046575138e-02 >>>> > > > > 372 KSP preconditioned resid norm 3.215039853884e-08 true resid >>>> norm 9.957541741887e-09 ||r(i)||/||b|| 2.251044314161e-02 >>>> > > > > 373 KSP preconditioned resid norm 3.191438320482e-08 true resid >>>> norm 8.943736857091e-09 ||r(i)||/||b|| 2.021859262192e-02 >>>> > > > > 374 KSP preconditioned resid norm 3.186200739666e-08 true resid >>>> norm 8.758295038024e-09 ||r(i)||/||b|| 1.979937494427e-02 >>>> > > > > 375 KSP preconditioned resid norm 3.183870059099e-08 true resid >>>> norm 8.943256269651e-09 ||r(i)||/||b|| 2.021750618548e-02 >>>> > > > > 376 KSP preconditioned resid norm 3.179122668815e-08 true resid >>>> norm 8.590862092304e-09 ||r(i)||/||b|| 1.942086889304e-02 >>>> > > > > 377 KSP preconditioned resid norm 3.167956879702e-08 true resid >>>> norm 9.582658100383e-09 ||r(i)||/||b|| 2.166296520824e-02 >>>> > > > > 378 KSP preconditioned resid norm 3.136955166729e-08 true resid >>>> norm 9.977269021243e-09 ||r(i)||/||b|| 2.255503946987e-02 >>>> > > > > 379 KSP preconditioned resid norm 3.130691641774e-08 true resid >>>> norm 8.509125545196e-09 ||r(i)||/||b|| 1.923609177194e-02 >>>> > > > > 380 KSP preconditioned resid norm 3.117879107848e-08 true resid >>>> norm 9.053973136302e-09 ||r(i)||/||b|| 2.046779745176e-02 >>>> > > > > 381 KSP preconditioned resid norm 3.088492490292e-08 true resid >>>> norm 1.048308325237e-08 ||r(i)||/||b|| 2.369850467295e-02 >>>> > > > > 382 KSP preconditioned resid norm 3.050052142818e-08 true resid >>>> norm 9.220813554635e-09 ||r(i)||/||b|| 2.084496401033e-02 >>>> > > > > 383 KSP preconditioned resid norm 2.985444875009e-08 true resid >>>> norm 1.234239992416e-08 ||r(i)||/||b|| 2.790175516463e-02 >>>> > > > > 384 KSP preconditioned resid norm 2.952644478108e-08 true resid >>>> norm 8.796660599472e-09 ||r(i)||/||b|| 1.988610576719e-02 >>>> > > > > 385 KSP preconditioned resid norm 2.923012320168e-08 true resid >>>> norm 9.047640736274e-09 ||r(i)||/||b|| 2.045348215843e-02 >>>> > > > > 386 KSP preconditioned resid norm 2.885571723790e-08 true resid >>>> norm 1.000194856842e-08 ||r(i)||/||b|| 2.261083110579e-02 >>>> > > > > 387 KSP preconditioned resid norm 2.854406928323e-08 true resid >>>> norm 7.861779671019e-09 ||r(i)||/||b|| 1.777267410608e-02 >>>> > > > > 388 KSP preconditioned resid norm 2.797557513811e-08 true resid >>>> norm 1.546960768219e-08 ||r(i)||/||b|| 3.497125426932e-02 >>>> > > > > 389 KSP preconditioned resid norm 2.745355913117e-08 true resid >>>> norm 7.687966698265e-09 ||r(i)||/||b|| 1.737974509390e-02 >>>> > > > > 390 KSP preconditioned resid norm 2.661217744985e-08 true resid >>>> norm 1.052014137922e-08 ||r(i)||/||b|| 2.378227985352e-02 >>>> > > > > 391 KSP preconditioned resid norm 2.658120474029e-08 true resid >>>> norm 9.465616738864e-09 ||r(i)||/||b|| 2.139837651939e-02 >>>> > > > > 392 KSP preconditioned resid norm 2.623787329422e-08 true resid >>>> norm 1.909951824281e-08 ||r(i)||/||b|| 4.317718474915e-02 >>>> > > > > 393 KSP preconditioned resid norm 2.543325628802e-08 true resid >>>> norm 5.948456163537e-09 ||r(i)||/||b|| 1.344733346046e-02 >>>> > > > > 394 KSP preconditioned resid norm 2.517323260201e-08 true resid >>>> norm 1.034609461157e-08 ||r(i)||/||b|| 2.338882231462e-02 >>>> > > > > 395 KSP preconditioned resid norm 2.490676685335e-08 true resid >>>> norm 8.641670445923e-09 ||r(i)||/||b|| 1.953572842212e-02 >>>> > > > > 396 KSP preconditioned resid norm 2.439513980463e-08 true resid >>>> norm 7.519572419040e-09 ||r(i)||/||b|| 1.699906581119e-02 >>>> > > > > 397 KSP preconditioned resid norm 2.414249722638e-08 true resid >>>> norm 1.073069104260e-08 ||r(i)||/||b|| 2.425825739384e-02 >>>> > > > > 398 KSP preconditioned resid norm 2.392817846978e-08 true resid >>>> norm 7.116187521104e-09 ||r(i)||/||b|| 1.608715672313e-02 >>>> > > > > 399 KSP preconditioned resid norm 2.371648249227e-08 true resid >>>> norm 1.098047911448e-08 ||r(i)||/||b|| 2.482293895233e-02 >>>> > > > > 400 KSP preconditioned resid norm 2.345879128128e-08 true resid >>>> norm 8.016833131810e-09 ||r(i)||/||b|| 1.812319456621e-02 >>>> > > > > 401 KSP preconditioned resid norm 2.331728390350e-08 true resid >>>> norm 7.808056352388e-09 ||r(i)||/||b|| 1.765122488290e-02 >>>> > > > > 402 KSP preconditioned resid norm 2.325356933312e-08 true resid >>>> norm 9.927418776284e-09 ||r(i)||/||b|| 2.244234588206e-02 >>>> > > > > 403 KSP preconditioned resid norm 2.314519860272e-08 true resid >>>> norm 7.444871113908e-09 ||r(i)||/||b|| 1.683019285787e-02 >>>> > > > > 404 KSP preconditioned resid norm 2.308308693430e-08 true resid >>>> norm 7.801054524067e-09 ||r(i)||/||b|| 1.763539625145e-02 >>>> > > > > 405 KSP preconditioned resid norm 2.306358661113e-08 true resid >>>> norm 7.805058505977e-09 ||r(i)||/||b|| 1.764444782357e-02 >>>> > > > > 406 KSP preconditioned resid norm 2.305322796876e-08 true resid >>>> norm 7.571079190824e-09 ||r(i)||/||b|| 1.711550421413e-02 >>>> > > > > 407 KSP preconditioned resid norm 2.298488633980e-08 true resid >>>> norm 8.830501095637e-09 ||r(i)||/||b|| 1.996260703473e-02 >>>> > > > > 408 KSP preconditioned resid norm 2.287294808434e-08 true resid >>>> norm 7.013326899093e-09 ||r(i)||/||b|| 1.585462561823e-02 >>>> > > > > 409 KSP preconditioned resid norm 2.286549605315e-08 true resid >>>> norm 7.082627748739e-09 ||r(i)||/||b|| 1.601129007177e-02 >>>> > > > > 410 KSP preconditioned resid norm 2.286053015844e-08 true resid >>>> norm 7.033545134087e-09 ||r(i)||/||b|| 1.590033182173e-02 >>>> > > > > 411 KSP preconditioned resid norm 2.280043141482e-08 true resid >>>> norm 7.319703904833e-09 ||r(i)||/||b|| 1.654723453179e-02 >>>> > > > > 412 KSP preconditioned resid norm 2.278834021186e-08 true resid >>>> norm 7.137620865339e-09 ||r(i)||/||b|| 1.613560985436e-02 >>>> > > > > 413 KSP preconditioned resid norm 2.274834174042e-08 true resid >>>> norm 7.536215034436e-09 ||r(i)||/||b|| 1.703668881668e-02 >>>> > > > > 414 KSP preconditioned resid norm 2.271641465026e-08 true resid >>>> norm 7.111204145035e-09 ||r(i)||/||b|| 1.607589109085e-02 >>>> > > > > 415 KSP preconditioned resid norm 2.271597283066e-08 true resid >>>> norm 7.105850673247e-09 ||r(i)||/||b|| 1.606378880442e-02 >>>> > > > > 416 KSP preconditioned resid norm 2.264562496921e-08 true resid >>>> norm 7.590206017147e-09 ||r(i)||/||b|| 1.715874313269e-02 >>>> > > > > 417 KSP preconditioned resid norm 2.264130303752e-08 true resid >>>> norm 7.322331610853e-09 ||r(i)||/||b|| 1.655317483599e-02 >>>> > > > > 418 KSP preconditioned resid norm 2.257869016612e-08 true resid >>>> norm 8.689110661905e-09 ||r(i)||/||b|| 1.964297379574e-02 >>>> > > > > 419 KSP preconditioned resid norm 2.252448770837e-08 true resid >>>> norm 7.589690206564e-09 ||r(i)||/||b|| 1.715757706931e-02 >>>> > > > > 420 KSP preconditioned resid norm 2.251854717911e-08 true resid >>>> norm 7.606351482008e-09 ||r(i)||/||b|| 1.719524225849e-02 >>>> > > > > 421 KSP preconditioned resid norm 2.251852680166e-08 true resid >>>> norm 7.587363564342e-09 ||r(i)||/||b|| 1.715231736276e-02 >>>> > > > > 422 KSP preconditioned resid norm 2.251740722171e-08 true resid >>>> norm 8.042777274478e-09 ||r(i)||/||b|| 1.818184500057e-02 >>>> > > > > 423 KSP preconditioned resid norm 2.251066763399e-08 true resid >>>> norm 7.161199860439e-09 ||r(i)||/||b|| 1.618891353535e-02 >>>> > > > > 424 KSP preconditioned resid norm 2.250468324723e-08 true resid >>>> norm 7.892076688728e-09 ||r(i)||/||b|| 1.784116483524e-02 >>>> > > > > 425 KSP preconditioned resid norm 2.248157980181e-08 true resid >>>> norm 7.381796123970e-09 ||r(i)||/||b|| 1.668760284806e-02 >>>> > > > > 426 KSP preconditioned resid norm 2.245901138193e-08 true resid >>>> norm 7.147464780092e-09 ||r(i)||/||b|| 1.615786342748e-02 >>>> > > > > 427 KSP preconditioned resid norm 2.241049755791e-08 true resid >>>> norm 8.351728267326e-09 ||r(i)||/||b|| 1.888027277907e-02 >>>> > > > > 428 KSP preconditioned resid norm 2.234407003838e-08 true resid >>>> norm 6.648970113909e-09 ||r(i)||/||b|| 1.503094514480e-02 >>>> > > > > 429 KSP preconditioned resid norm 2.225463790450e-08 true resid >>>> norm 9.144039069449e-09 ||r(i)||/||b|| 2.067140433784e-02 >>>> > > > > 430 KSP preconditioned resid norm 2.219515360063e-08 true resid >>>> norm 7.964312082788e-09 ||r(i)||/||b|| 1.800446324492e-02 >>>> > > > > 431 KSP preconditioned resid norm 2.207622538143e-08 true resid >>>> norm 7.744159741884e-09 ||r(i)||/||b|| 1.750677748263e-02 >>>> > > > > 432 KSP preconditioned resid norm 2.189830543256e-08 true resid >>>> norm 1.088914113364e-08 ||r(i)||/||b|| 2.461645642103e-02 >>>> > > > > 433 KSP preconditioned resid norm 2.136231265645e-08 true resid >>>> norm 6.923381943847e-09 ||r(i)||/||b|| 1.565129221995e-02 >>>> > > > > 434 KSP preconditioned resid norm 2.037470395914e-08 true resid >>>> norm 1.030114953089e-08 ||r(i)||/||b|| 2.328721755017e-02 >>>> > > > > 435 KSP preconditioned resid norm 1.961890283205e-08 true resid >>>> norm 7.295267301635e-09 ||r(i)||/||b|| 1.649199210539e-02 >>>> > > > > 436 KSP preconditioned resid norm 1.913560642295e-08 true resid >>>> norm 6.039280397468e-09 ||r(i)||/||b|| 1.365265459361e-02 >>>> > > > > 437 KSP preconditioned resid norm 1.877609800000e-08 true resid >>>> norm 8.984892222755e-09 ||r(i)||/||b|| 2.031163019513e-02 >>>> > > > > 438 KSP preconditioned resid norm 1.811081731215e-08 true resid >>>> norm 6.564934723165e-09 ||r(i)||/||b|| 1.484097115983e-02 >>>> > > > > 439 KSP preconditioned resid norm 1.785755067179e-08 true resid >>>> norm 5.336927073942e-09 ||r(i)||/||b|| 1.206488474394e-02 >>>> > > > > 440 KSP preconditioned resid norm 1.772971743003e-08 true resid >>>> norm 4.970154886573e-09 ||r(i)||/||b|| 1.123574390942e-02 >>>> > > > > 441 KSP preconditioned resid norm 1.735301571457e-08 true resid >>>> norm 5.652698869454e-09 ||r(i)||/||b|| 1.277873191957e-02 >>>> > > > > 442 KSP preconditioned resid norm 1.631139023345e-08 true resid >>>> norm 7.160283137945e-09 ||r(i)||/||b|| 1.618684115342e-02 >>>> > > > > 443 KSP preconditioned resid norm 1.483956291991e-08 true resid >>>> norm 7.988466840254e-09 ||r(i)||/||b|| 1.805906851886e-02 >>>> > > > > 444 KSP preconditioned resid norm 1.410013314968e-08 true resid >>>> norm 7.482143551338e-09 ||r(i)||/||b|| 1.691445251806e-02 >>>> > > > > 445 KSP preconditioned resid norm 1.356330060794e-08 true resid >>>> norm 3.083065574605e-09 ||r(i)||/||b|| 6.969709403983e-03 >>>> > > > > 446 KSP preconditioned resid norm 1.314115350470e-08 true resid >>>> norm 4.164976230172e-09 ||r(i)||/||b|| 9.415522730979e-03 >>>> > > > > 447 KSP preconditioned resid norm 1.236636402318e-08 true resid >>>> norm 5.761202097878e-09 ||r(i)||/||b|| 1.302401894094e-02 >>>> > > > > 448 KSP preconditioned resid norm 1.180595146541e-08 true resid >>>> norm 4.038199940007e-09 ||r(i)||/||b|| 9.128926847635e-03 >>>> > > > > 449 KSP preconditioned resid norm 1.131424900987e-08 true resid >>>> norm 5.090038236142e-09 ||r(i)||/||b|| 1.150675731755e-02 >>>> > > > > 450 KSP preconditioned resid norm 1.063388583397e-08 true resid >>>> norm 3.010230442125e-09 ||r(i)||/||b|| 6.805055200074e-03 >>>> > > > > 451 KSP preconditioned resid norm 1.051458985758e-08 true resid >>>> norm 1.649000916776e-09 ||r(i)||/||b|| 3.727801734579e-03 >>>> > > > > 452 KSP preconditioned resid norm 1.012147631812e-08 true resid >>>> norm 5.884734670038e-09 ||r(i)||/||b|| 1.330328193716e-02 >>>> > > > > 453 KSP preconditioned resid norm 9.390240831193e-09 true resid >>>> norm 2.031511507263e-09 ||r(i)||/||b|| 4.592521473788e-03 >>>> > > > > 454 KSP preconditioned resid norm 9.098339938653e-09 true resid >>>> norm 1.769428017679e-09 ||r(i)||/||b|| 4.000044370146e-03 >>>> > > > > 455 KSP preconditioned resid norm 8.890748233216e-09 true resid >>>> norm 2.050221736547e-09 ||r(i)||/||b|| 4.634818615330e-03 >>>> > > > > 456 KSP preconditioned resid norm 8.527203662681e-09 true resid >>>> norm 2.051638846865e-09 ||r(i)||/||b|| 4.638022195295e-03 >>>> > > > > 457 KSP preconditioned resid norm 8.268992410262e-09 true resid >>>> norm 2.382052265392e-09 ||r(i)||/||b|| 5.384968847771e-03 >>>> > > > > 458 KSP preconditioned resid norm 7.908973261474e-09 true resid >>>> norm 3.438027649085e-09 ||r(i)||/||b|| 7.772151794095e-03 >>>> > > > > 459 KSP preconditioned resid norm 7.427882465376e-09 true resid >>>> norm 2.945117076322e-09 ||r(i)||/||b|| 6.657857150931e-03 >>>> > > > > 460 KSP preconditioned resid norm 7.015919500900e-09 true resid >>>> norm 1.769207642661e-09 ||r(i)||/||b|| 3.999546180990e-03 >>>> > > > > 461 KSP preconditioned resid norm 6.803968849346e-09 true resid >>>> norm 1.305695673120e-09 ||r(i)||/||b|| 2.951711272911e-03 >>>> > > > > 462 KSP preconditioned resid norm 6.710918799980e-09 true resid >>>> norm 1.795032965660e-09 ||r(i)||/||b|| 4.057928006550e-03 >>>> > > > > 463 KSP preconditioned resid norm 6.577483627377e-09 true resid >>>> norm 1.782001044516e-09 ||r(i)||/||b|| 4.028467490336e-03 >>>> > > > > 464 KSP preconditioned resid norm 6.417912605066e-09 true resid >>>> norm 1.290960823243e-09 ||r(i)||/||b|| 2.918401043442e-03 >>>> > > > > 465 KSP preconditioned resid norm 6.365751616365e-09 true resid >>>> norm 1.263290494523e-09 ||r(i)||/||b|| 2.855848319336e-03 >>>> > > > > 466 KSP preconditioned resid norm 6.293400160765e-09 true resid >>>> norm 1.425147805149e-09 ||r(i)||/||b|| 3.221749852300e-03 >>>> > > > > 467 KSP preconditioned resid norm 5.891998607109e-09 true resid >>>> norm 2.318264750150e-09 ||r(i)||/||b|| 5.240768072899e-03 >>>> > > > > 468 KSP preconditioned resid norm 5.803460471252e-09 true resid >>>> norm 1.081820742140e-09 ||r(i)||/||b|| 2.445610064874e-03 >>>> > > > > 469 KSP preconditioned resid norm 5.754085062170e-09 true resid >>>> norm 1.656644764768e-09 ||r(i)||/||b|| 3.745081743044e-03 >>>> > > > > 470 KSP preconditioned resid norm 5.525556632876e-09 true resid >>>> norm 1.979760762585e-09 ||r(i)||/||b|| 4.475531535326e-03 >>>> > > > > 471 KSP preconditioned resid norm 5.443965422137e-09 true resid >>>> norm 9.955797379882e-10 ||r(i)||/||b|| 2.250649976253e-03 >>>> > > > > 472 KSP preconditioned resid norm 5.414797083501e-09 true resid >>>> norm 1.143450718543e-09 ||r(i)||/||b|| 2.584933415516e-03 >>>> > > > > 473 KSP preconditioned resid norm 5.408283291827e-09 true resid >>>> norm 1.029764590400e-09 ||r(i)||/||b|| 2.327929710194e-03 >>>> > > > > 474 KSP preconditioned resid norm 5.355045752288e-09 true resid >>>> norm 1.886388210190e-09 ||r(i)||/||b|| 4.264449564882e-03 >>>> > > > > 475 KSP preconditioned resid norm 5.241533530016e-09 true resid >>>> norm 1.425455398363e-09 ||r(i)||/||b|| 3.222445210625e-03 >>>> > > > > 476 KSP preconditioned resid norm 5.125189682735e-09 true resid >>>> norm 1.354368288121e-09 ||r(i)||/||b|| 3.061742660270e-03 >>>> > > > > 477 KSP preconditioned resid norm 5.057977457429e-09 true resid >>>> norm 1.740562818023e-09 ||r(i)||/||b|| 3.934790469888e-03 >>>> > > > > 478 KSP preconditioned resid norm 4.979286088604e-09 true resid >>>> norm 1.417735808423e-09 ||r(i)||/||b|| 3.204993976684e-03 >>>> > > > > 479 KSP preconditioned resid norm 4.894533209216e-09 true resid >>>> norm 1.326984715102e-09 ||r(i)||/||b|| 2.999838188318e-03 >>>> > > > > 480 KSP preconditioned resid norm 4.777786489681e-09 true resid >>>> norm 1.456212644054e-09 ||r(i)||/||b|| 3.291976350766e-03 >>>> > > > > 481 KSP preconditioned resid norm 4.775308813328e-09 true resid >>>> norm 1.364283691096e-09 ||r(i)||/||b|| 3.084157842718e-03 >>>> > > > > 482 KSP preconditioned resid norm 4.760397485605e-09 true resid >>>> norm 2.049838358389e-09 ||r(i)||/||b|| 4.633951934330e-03 >>>> > > > > 483 KSP preconditioned resid norm 4.670996943034e-09 true resid >>>> norm 8.889456596556e-10 ||r(i)||/||b|| 2.009588435214e-03 >>>> > > > > 484 KSP preconditioned resid norm 4.597559289814e-09 true resid >>>> norm 1.386989122943e-09 ||r(i)||/||b|| 3.135486709406e-03 >>>> > > > > 485 KSP preconditioned resid norm 4.570207496163e-09 true resid >>>> norm 1.099843879320e-09 ||r(i)||/||b|| 2.486353936728e-03 >>>> > > > > 486 KSP preconditioned resid norm 4.542158022055e-09 true resid >>>> norm 1.011236566485e-09 ||r(i)||/||b|| 2.286044469873e-03 >>>> > > > > 487 KSP preconditioned resid norm 4.526766510181e-09 true resid >>>> norm 1.399400517345e-09 ||r(i)||/||b|| 3.163544436426e-03 >>>> > > > > 488 KSP preconditioned resid norm 4.505705850329e-09 true resid >>>> norm 9.117728324580e-10 ||r(i)||/||b|| 2.061192514692e-03 >>>> > > > > 489 KSP preconditioned resid norm 4.487150083935e-09 true resid >>>> norm 1.381092775475e-09 ||r(i)||/||b|| 3.122157175082e-03 >>>> > > > > 490 KSP preconditioned resid norm 4.473919835893e-09 true resid >>>> norm 9.652867482479e-10 ||r(i)||/||b|| 2.182168352895e-03 >>>> > > > > 491 KSP preconditioned resid norm 4.452517186816e-09 true resid >>>> norm 1.131636320873e-09 ||r(i)||/||b|| 2.558225284743e-03 >>>> > > > > 492 KSP preconditioned resid norm 4.400952072877e-09 true resid >>>> norm 1.786271233792e-09 ||r(i)||/||b|| 4.038120862161e-03 >>>> > > > > 493 KSP preconditioned resid norm 4.366719039095e-09 true resid >>>> norm 1.028221901066e-09 ||r(i)||/||b|| 2.324442240954e-03 >>>> > > > > 494 KSP preconditioned resid norm 4.331818466820e-09 true resid >>>> norm 1.573868226869e-09 ||r(i)||/||b|| 3.557953574452e-03 >>>> > > > > 495 KSP preconditioned resid norm 4.302438670088e-09 true resid >>>> norm 1.043943800033e-09 ||r(i)||/||b|| 2.359983835651e-03 >>>> > > > > 496 KSP preconditioned resid norm 4.254710406786e-09 true resid >>>> norm 1.390625661617e-09 ||r(i)||/||b|| 3.143707623679e-03 >>>> > > > > 497 KSP preconditioned resid norm 4.221208729086e-09 true resid >>>> norm 1.442390433810e-09 ||r(i)||/||b|| 3.260729273340e-03 >>>> > > > > 498 KSP preconditioned resid norm 4.194726771303e-09 true resid >>>> norm 1.122208863419e-09 ||r(i)||/||b|| 2.536913172729e-03 >>>> > > > > 499 KSP preconditioned resid norm 4.161552261100e-09 true resid >>>> norm 1.685040004550e-09 ||r(i)||/||b|| 3.809273231987e-03 >>>> > > > > 500 KSP preconditioned resid norm 4.157891682720e-09 true resid >>>> norm 1.444023641507e-09 ||r(i)||/||b|| 3.264421372248e-03 >>>> > > > > >>>> > > > > >>>> > > > > >>>> > > > > >>>> > > > > 2018-08-06 15:40 GMT-05:00 Smith, Barry F. >>> >: >>>> > > > > >>>> > > > > Ok, I think you want to use PCFIELDSPLIT with two fields u >>>> and c. Start by using PC_COMPOSITE_MULTIPLICATIVE with direct solvers (LU) >>>> for each field. Then try replacing the direct solvers LU with hypre >>>> BoomerAMG first one at a time. >>>> > > > > >>>> > > > > Let us know how it goes and we'll make additional >>>> suggestions, >>>> > > > > >>>> > > > > Barry >>>> > > > > >>>> > > > > >>>> > > > > > On Aug 6, 2018, at 12:58 PM, Josh L >>>> wrote: >>>> > > > > > >>>> > > > > > Hi Barry, >>>> > > > > > >>>> > > > > > (1) >>>> > > > > > I am basically solving the equilibrium coupled with phase >>>> field equation: >>>> > > > > > >>>> > > > > > 1-D example >>>> > > > > > u is displacement and c is phase-field parameter. >>>> > > > > > >>>> > > > > > equilibrium: (c^2)*E* (\Delta u) = 0 >>>> > > > > > >>>> > > > > > phase-field equation: 2*G_c*L*(\Delta >>>> c)-E*(\epsilon)^2*c+G_c/2L(1-c)=0 >>>> > > > > > >>>> > > > > > I solve the above 2 equations coupled. >>>> > > > > > it is the formulation for quasi-static fracture problem, >>>> where G_c is the critical energy release rate and L is the length scale in >>>> phase-field method (both constant). >>>> > > > > > >>>> > > > > > The free energy I am using now is >>>> > > > > > 1-D: >>>> > > > > > >>>> > > > > > \psi=c^2*0.5*E*\epsilon^2+G_c/4L*(1-c)^2+G_c*L*grad c * grad >>>> c >>>> > > > > > >>>> > > > > > >>>> > > > > > it is not convex w.r.t u and c simultaneously. >>>> > > > > > >>>> > > > > > (2) >>>> > > > > > >>>> > > > > > with an appropriate step size. Newton's method usually >>>> converges with 5 iteration, and I can see the quadratic convergence of >>>> Newton's method. >>>> > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > > Thanks, >>>> > > > > > Josh >>>> > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > > 2018-08-05 22:23 GMT-05:00 Smith, Barry F. < >>>> bsmith at mcs.anl.gov>: >>>> > > > > > >>>> > > > > > >>>> > > > > > > On Aug 5, 2018, at 9:38 PM, Josh L >>>> wrote: >>>> > > > > > > >>>> > > > > > > Hi, >>>> > > > > > > >>>> > > > > > > I am using GRMES to solve the linear systems within Newton >>>> Raphson. >>>> > > > > > > I am using finite element method to solve fracture problem >>>> with phase field method.(the formulation gives symmetric but indefinite >>>> hessian so can't use CG) >>>> > > > > > >>>> > > > > > What exact equations are you using for the phase field >>>> method? >>>> > > > > > >>>> > > > > > With the direct LU solver roughly how many iterations >>>> does your Newton's method take? >>>> > > > > > >>>> > > > > > >>>> > > > > > Barry >>>> > > > > > >>>> > > > > > > >>>> > > > > > > The total iteration number to solve one linear system is >>>> often very large( > 2000) even for a small sized problem(120K degree of >>>> freedom). I've tried different preconditioner, but it doesn't help a lot. >>>> I have checked my hessian and right hand side, and sure they are correct. >>>> > > > > > > >>>> > > > > > > I think it might stem from the great difference in element >>>> size(max/min=100) and damage stiffness around crack. >>>> > > > > > > >>>> > > > > > > Anyone has idea to reduce the number of iteration? >>>> > > > > > > >>>> > > > > > > Now, I get away with it by using LU, which is not ideal for >>>> large size problem (I will have to run it in the future) >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > Thanks, >>>> > > > > > > Josh >>>> > > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > >>>> > > > > >>>> > > > >>>> > > > >>>> > >>>> > >>>> >>>> >>> >>> -- >>> 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 >>> >>> https://www.cse.buffalo.edu/~knepley/ >>> >> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: mat Type: application/octet-stream Size: 17555128 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: rhs Type: application/octet-stream Size: 646424 bytes Desc: not available URL: From arkhazali at cc.iut.ac.ir Thu Aug 16 01:59:56 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Thu, 16 Aug 2018 11:29:56 +0430 Subject: [petsc-users] Problem in compiling PETSc+ML Message-ID: <47fa292d-fccb-103a-24b1-9c6893734e82@cc.iut.ac.ir> Hi, I have been using PETSc on a MS windows 7 x64 system with Intel MKL, MPI and compilers without problem. For an specific problem, I had to use ML. However, I could not compile ML with the before-mentioned toolsets.? The the log files (PETSc and ML) are attached. Any help is much appreciated. Thanks, Ali -------------- next part -------------- This file contains any messages produced by compilers while running configure, to aid debugging if configure makes a mistake. It was created by ml configure 6.2, which was generated by GNU Autoconf 2.69. Invocation command line was $ ./configure --prefix=/home/alireza/Petsc393Install MAKE=/usr/bin/make --libdir=/home/alireza/Petsc393Install/lib CC=/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl CFLAGS=-O2 -MT -wd4996 -Qopenmp AR=/usr/bin/ar ARFLAGS=cr CXX=/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl CXXFLAGS=-O2 -MT -wd4996 -Qopenmp -TP F90=/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort F90FLAGS=-MT -O2 -Qopenmp -fpp F77=/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort FFLAGS=-MT -O2 -Qopenmp -fpp FC=/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort FCFLAGS=-MT -O2 -Qopenmp -fpp --disable-shared --disable-ml-epetra --disable-ml-aztecoo --disable-ml-examples --disable-tests --enable-libcheck --with-cflags=-O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include CPPFLAGS=-I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-fflags=-MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-cxxflags=-O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --enable-mpi --with-mpi-libs=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib --with-blas=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib ## --------- ## ## Platform. ## ## --------- ## hostname = AliReza-PC uname -m = x86_64 uname -r = 2.10.0(0.325/5/3) uname -s = CYGWIN_NT-6.1 uname -v = 2018-02-02 15:16 /usr/bin/uname -p = unknown /bin/uname -X = unknown /bin/arch = x86_64 /usr/bin/arch -k = unknown /usr/convex/getsysinfo = unknown /usr/bin/hostinfo = unknown /bin/machine = unknown /usr/bin/oslevel = unknown /bin/universe = unknown PATH: /usr/bin PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/bin/intel64 PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/compiler PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.15.26726/bin/HostX64/x64 PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/VC/VCPackages PATH: /cygdrive/c/Program Files (x86)/Microsoft SDKs/TypeScript/3.0 PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TestWindow PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TeamFoundation/Team Explorer PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/Roslyn PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/x64 PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/x64 PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools PATH: /cygdrive/c/Program Files (x86)/Microsoft SDKs/Windows/v10.0A/bin/NETFX 4.6.1 Tools/x64 PATH: /cygdrive/c/Program Files (x86)/HTML Help Workshop PATH: /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/10.0.17134.0/x64 PATH: /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/x64 PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin PATH: /cygdrive/c/Windows/Microsoft.NET/Framework64/v4.0.30319 PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/Tools PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/gdb/intel64/bin PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/libipt/intel64/lib PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/ipp PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/daal PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/tbb/vc_mt PATH: /cygdrive/c/Program Files (x86)/Common Files/Oracle/Java/javapath PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries_2018.3.210/windows/mpi/intel64/bin PATH: /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/mpirt PATH: /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/mpirt PATH: /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/compiler PATH: /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/compiler PATH: /cygdrive/e/Python37/Scripts PATH: /cygdrive/e/Python37 PATH: /cygdrive/e/Program Files (x86)/IntelSWTools/mpi/2018.1.156/intel64/bin PATH: /cygdrive/c/Program Files/Microsoft MPI/Bin PATH: /cygdrive/c/Program Files (x86)/Intel/MPI-RT/4.1.3.045/em64t/bin PATH: /cygdrive/c/Program Files (x86)/CMG/CMGJobService PATH: /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.3.050/intel64/bin PATH: /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/mpirt PATH: /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/mpirt PATH: /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/compiler PATH: /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/compiler PATH: /cygdrive/c/ProgramData/Oracle/Java/javapath PATH: /cygdrive/c/Python27 PATH: /cygdrive/c/Python27/Scripts PATH: /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/bin PATH: /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.2.044/intel64/bin PATH: /cygdrive/c/Program Files (x86)/Intel/Composer XE 2015/bin/ia32 PATH: /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86_64 PATH: /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86 PATH: /cygdrive/c/Progra PATH: /cygdrive/c/Windows/System32 PATH: /cygdrive/c/Program Files (x86)/Microsoft Visual Studio 14.0/Common7/IDE PATH: /cygdrive/e/Program Files/PuTTY PATH: /cygdrive/c/ecl/HOME PATH: /cygdrive/c/ecl/MACROS PATH: /cygdrive/e/Program Files/CMake/bin PATH: /cygdrive/e/ecl/HOME PATH: /cygdrive/e/ecl/MACROS PATH: /cygdrive/c/Program Files/dotnet PATH: /cygdrive/c/Program Files/Microsoft SQL Server/130/Tools/Binn PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.14.26428/bin/Hostx64/x64 PATH: /cygdrive/e/Program Files (x86)/IncrediBuild PATH: /cygdrive/e/Python36/Scripts PATH: /cygdrive/e/Python36 PATH: /cygdrive/c/Users/AliReza/.dnx/bin PATH: /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/dll PATH: /cygdrive/c/Program Files (x86)/SSH Communications Security/SSH Secure Shell PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/CMake/bin PATH: /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/Ninja ## ----------- ## ## Core tests. ## ## ----------- ## configure:2775: checking whether to enable maintainer-specific portions of Makefiles configure:2784: result: no configure:2804: checking build system type configure:2818: result: x86_64-unknown-cygwin configure:2838: checking host system type configure:2851: result: x86_64-unknown-cygwin configure:2871: checking target system type configure:2884: result: x86_64-unknown-cygwin configure:2929: checking for a BSD-compatible install configure:2997: result: /usr/bin/install -c configure:3008: checking whether build environment is sane configure:3063: result: yes configure:3214: checking for a thread-safe mkdir -p configure:3253: result: /usr/bin/mkdir -p configure:3260: checking for gawk configure:3276: found /usr/bin/gawk configure:3287: result: gawk configure:3298: checking whether /usr/bin/make sets $(MAKE) configure:3320: result: yes configure:3349: checking whether /usr/bin/make supports nested variables configure:3366: result: yes configure:3446: checking whether UID '197608' is supported by ustar format configure:3449: result: yes configure:3456: checking whether GID '197121' is supported by ustar format configure:3459: result: yes configure:3467: checking how to create a ustar tar archive configure:3478: tar --version tar (GNU tar) 1.29 Packaged by Cygwin (1.29-1) Copyright (C) 2015 Free Software Foundation, Inc. License GPLv3+: GNU GPL version 3 or later . This is free software: you are free to change and redistribute it. There is NO WARRANTY, to the extent permitted by law. Written by John Gilmore and Jay Fenlason. configure:3481: $? = 0 configure:3521: tardir=conftest.dir && eval tar --format=ustar -chf - "$tardir" >conftest.tar configure:3524: $? = 0 configure:3528: tar -xf - &5 Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Intel(R) C++ Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 configure:4118: $? = 0 configure:4107: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -v >&5 icl: command line warning #10006: ignoring unknown option '/v' icl: command line error: no files specified; for help type "icl /help" configure:4118: $? = 1 configure:4107: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -V >&5 icl: command line error: no files specified; for help type "icl /help" configure:4118: $? = 1 configure:4107: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -qversion >&5 icl: command line warning #10006: ignoring unknown option '/qversion' icl: command line error: no files specified; for help type "icl /help" configure:4118: $? = 1 configure:4138: checking whether the C++ compiler works configure:4160: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:4164: $? = 0 configure:4212: result: yes configure:4215: checking for C++ compiler default output file name configure:4217: result: conftest.exe configure:4223: checking for suffix of executables configure:4230: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:4234: $? = 0 configure:4256: result: .exe configure:4278: checking whether we are cross compiling configure:4286: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:4290: $? = 0 configure:4297: ./conftest.exe configure:4301: $? = 0 configure:4316: result: no configure:4321: checking for suffix of object files configure:4343: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:4347: $? = 0 configure:4368: result: o configure:4372: checking whether we are using the GNU C++ compiler configure:4391: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.cpp(15): error: identifier "choke" is undefined choke me ^ compilation aborted for E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.cpp (code 2) configure:4391: $? = 2 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | /* end confdefs.h. */ | | int | main () | { | #ifndef __GNUC__ | choke me | #endif | | ; | return 0; | } configure:4400: result: no configure:4409: checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl accepts -g configure:4429: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -g -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:4429: $? = 0 configure:4470: result: yes configure:4504: checking for style of include used by /usr/bin/make configure:4532: result: GNU configure:4558: checking dependency style of /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl configure:4669: result: msvc7 configure:4821: checking for C compiler version configure:4830: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl --version >&5 Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Intel(R) C++ Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 configure:4841: $? = 0 configure:4830: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -v >&5 icl: command line warning #10006: ignoring unknown option '/v' icl: command line error: no files specified; for help type "icl /help" configure:4841: $? = 1 configure:4830: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -V >&5 icl: command line error: no files specified; for help type "icl /help" configure:4841: $? = 1 configure:4830: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -qversion >&5 icl: command line warning #10006: ignoring unknown option '/qversion' icl: command line error: no files specified; for help type "icl /help" configure:4841: $? = 1 configure:4845: checking whether we are using the GNU C compiler configure:4864: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c >&5 conftest.c E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.c(15): error: identifier "choke" is undefined choke me ^ compilation aborted for E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.c (code 2) configure:4864: $? = 2 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | /* end confdefs.h. */ | | int | main () | { | #ifndef __GNUC__ | choke me | #endif | | ; | return 0; | } configure:4873: result: no configure:4882: checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl accepts -g configure:4902: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -g -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c >&5 conftest.c configure:4902: $? = 0 configure:4943: result: yes configure:4960: checking for /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl option to accept ISO C89 configure:5023: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c >&5 conftest.c configure:5023: $? = 0 configure:5036: result: none needed configure:5061: checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl understands -c and -o together configure:5083: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c conftest.c -o conftest2.o conftest.c configure:5086: $? = 0 configure:5083: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c conftest.c -o conftest2.o conftest.c configure:5086: $? = 0 configure:5098: result: yes configure:5117: checking dependency style of /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl configure:5228: result: msvc7 configure:5349: checking for Fortran 77 compiler version configure:5358: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort --version >&5 Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Intel(R) Visual Fortran Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 configure:5369: $? = 0 configure:5358: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -v >&5 ifort: command line warning #10006: ignoring unknown option '/v' ifort: command line error: no files specified; for help type "ifort /help" configure:5369: $? = 1 configure:5358: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -V >&5 ifort: command line error: no files specified; for help type "ifort /help" configure:5369: $? = 1 configure:5358: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -qversion >&5 ifort: command line warning #10006: ignoring unknown option '/qversion' ifort: command line error: no files specified; for help type "ifort /help" configure:5369: $? = 1 configure:5378: checking whether we are using the GNU Fortran 77 compiler configure:5391: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -MT -O2 -Qopenmp -fpp conftest.F >&5 E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.F(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : choke me ---------------^ compilation aborted for E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.F (code 1) configure:5391: $? = 1 configure: failed program was: | program main | #ifndef __GNUC__ | choke me | #endif | | end configure:5400: result: no configure:5406: checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort accepts -g configure:5417: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -g conftest.f >&5 configure:5417: $? = 0 configure:5425: result: yes configure:5497: checking for ranlib configure:5513: found /usr/bin/ranlib configure:5524: result: ranlib configure:5554: checking finding build directory configure:5557: result: /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml configure:5580: checking whether additional CCFLAGS flags should be added configure:5591: result: no configure:5598: checking whether additional CXXFLAGS flags should be added configure:5605: result: CXXFLAGS = -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP configure:5636: checking whether additional CFLAGS flags should be added configure:5643: result: CFLAGS = -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp configure:5654: checking whether additional FFLAGS flags should be added configure:5661: result: FFLAGS = -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -MT -O2 -Qopenmp -fpp configure:5672: checking whether additional libraries are needed configure:5683: result: no configure:5691: checking whether additional LDFLAGS flags should be added configure:5702: result: no configure:5735: checking for special archiver command configure:5749: result: none configure:5772: checking how to run the C++ preprocessor configure:5799: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:5799: $? = 0 configure:5813: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:5813: $? = 2 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | /* end confdefs.h. */ | #include configure:5838: result: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E configure:5858: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:5858: $? = 0 configure:5872: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:5872: $? = 2 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | /* end confdefs.h. */ | #include configure:5919: checking for mpi.h configure:5925: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:5925: $? = 0 configure:5926: result: yes configure:5989: checking whether to build export makefiles configure:5994: result: yes configure:6066: checking for perl configure:6082: found /usr/bin/perl configure:6094: result: yes configure:6136: checking whether gnumake specific code should be enabled configure:6146: result: no configure:6175: checking for grep that handles long lines and -e configure:6233: result: /usr/bin/grep configure:6238: checking for egrep configure:6300: result: /usr/bin/grep -E configure:6305: checking for ANSI C header files configure:6325: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6325: $? = 0 configure:6398: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib >&5 conftest.cpp configure:6398: $? = 0 configure:6398: ./conftest.exe configure:6398: $? = 0 configure:6409: result: yes configure:6422: checking for sys/types.h configure:6422: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6422: $? = 0 configure:6422: result: yes configure:6422: checking for sys/stat.h configure:6422: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6422: $? = 0 configure:6422: result: yes configure:6422: checking for stdlib.h configure:6422: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6422: $? = 0 configure:6422: result: yes configure:6422: checking for string.h configure:6422: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6422: $? = 0 configure:6422: result: yes configure:6422: checking for memory.h configure:6422: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6422: $? = 0 configure:6422: result: yes configure:6422: checking for strings.h configure:6422: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.cpp(51): catastrophic error: cannot open source file "strings.h" #include ^ compilation aborted for E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.cpp (code 4) configure:6422: $? = 4 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | /* end confdefs.h. */ | #include | #ifdef HAVE_SYS_TYPES_H | # include | #endif | #ifdef HAVE_SYS_STAT_H | # include | #endif | #ifdef STDC_HEADERS | # include | # include | #else | # ifdef HAVE_STDLIB_H | # include | # endif | #endif | #ifdef HAVE_STRING_H | # if !defined STDC_HEADERS && defined HAVE_MEMORY_H | # include | # endif | # include | #endif | #ifdef HAVE_STRINGS_H | # include | #endif | #ifdef HAVE_INTTYPES_H | # include | #endif | #ifdef HAVE_STDINT_H | # include | #endif | #ifdef HAVE_UNISTD_H | # include | #endif | | #include configure:6422: result: no configure:6422: checking for inttypes.h configure:6422: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6422: $? = 0 configure:6422: result: yes configure:6422: checking for stdint.h configure:6422: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6422: $? = 0 configure:6422: result: yes configure:6422: checking for unistd.h configure:6422: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.cpp(53): catastrophic error: cannot open source file "unistd.h" #include ^ compilation aborted for E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.cpp (code 4) configure:6422: $? = 4 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | /* end confdefs.h. */ | #include | #ifdef HAVE_SYS_TYPES_H | # include | #endif | #ifdef HAVE_SYS_STAT_H | # include | #endif | #ifdef STDC_HEADERS | # include | # include | #else | # ifdef HAVE_STDLIB_H | # include | # endif | #endif | #ifdef HAVE_STRING_H | # if !defined STDC_HEADERS && defined HAVE_MEMORY_H | # include | # endif | # include | #endif | #ifdef HAVE_STRINGS_H | # include | #endif | #ifdef HAVE_INTTYPES_H | # include | #endif | #ifdef HAVE_STDINT_H | # include | #endif | #ifdef HAVE_UNISTD_H | # include | #endif | | #include configure:6422: result: no configure:6437: checking cstdlib usability configure:6437: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6437: $? = 0 configure:6437: result: yes configure:6437: checking cstdlib presence configure:6437: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:6437: $? = 0 configure:6437: result: yes configure:6437: checking for cstdlib configure:6437: result: yes configure:6450: checking cstdio usability configure:6450: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6450: $? = 0 configure:6450: result: yes configure:6450: checking cstdio presence configure:6450: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:6450: $? = 0 configure:6450: result: yes configure:6450: checking for cstdio configure:6450: result: yes configure:6463: checking cassert usability configure:6463: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6463: $? = 0 configure:6463: result: yes configure:6463: checking cassert presence configure:6463: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:6463: $? = 0 configure:6463: result: yes configure:6463: checking for cassert configure:6463: result: yes configure:6476: checking cmath usability configure:6476: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6476: $? = 0 configure:6476: result: yes configure:6476: checking cmath presence configure:6476: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:6476: $? = 0 configure:6476: result: yes configure:6476: checking for cmath configure:6476: result: yes configure:6489: checking iomanip usability configure:6489: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6489: $? = 0 configure:6489: result: yes configure:6489: checking iomanip presence configure:6489: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:6489: $? = 0 configure:6489: result: yes configure:6489: checking for iomanip configure:6489: result: yes configure:6502: checking iostream usability configure:6502: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6502: $? = 0 configure:6502: result: yes configure:6502: checking iostream presence configure:6502: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:6502: $? = 0 configure:6502: result: yes configure:6502: checking for iostream configure:6502: result: yes configure:6515: checking string usability configure:6515: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6515: $? = 0 configure:6515: result: yes configure:6515: checking string presence configure:6515: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:6515: $? = 0 configure:6515: result: yes configure:6515: checking for string configure:6515: result: yes configure:6527: checking malloc.h usability configure:6527: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6527: $? = 0 configure:6527: result: yes configure:6527: checking malloc.h presence configure:6527: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp configure:6527: $? = 0 configure:6527: result: yes configure:6527: checking for malloc.h configure:6527: result: yes configure:6643: checking for inline configure:6659: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6659: $? = 0 configure:6667: result: inline configure:6690: checking whether the compiler implements namespaces configure:6713: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6713: $? = 0 configure:6727: result: yes configure:6735: checking whether the compiler supports Standard Template Library configure:6764: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6764: $? = 0 configure:6778: result: yes configure:6786: checking whether the compiler recognizes bool as a built-in type configure:6813: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6813: $? = 0 configure:6827: result: yes configure:6835: checking whether the compiler supports the mutable keyword configure:6863: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6863: $? = 0 configure:6877: result: yes configure:6888: checking whether the compiler accepts the new for scoping rules configure:6917: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6917: $? = 0 configure:6931: result: yes configure:6940: checking whether the compiler recognizes std::sprintf as supported IO function configure:6970: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6970: $? = 0 configure:6995: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:6995: $? = 0 configure:7015: result: yes configure:7024: checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl recognizes __PRETTY_FUNCTION__ configure:7037: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.cpp >&5 conftest.cpp configure:7037: $? = 0 configure:7055: result: yes configure:7133: checking whether to use ml_newtpe configure:7137: result: yes configure:7160: checking whether to use ml_enrich configure:7170: result: no configure:7185: checking whether to use ml_aztec2_1 configure:7195: result: no configure:7209: checking whether to use ml_complex_maxwell configure:7219: result: no configure:7234: checking whether to use ml_timing configure:7244: result: no configure:7258: checking whether to use ml_memory_checking configure:7268: result: no configure:7282: checking whether to use ml_flops configure:7292: result: no configure:7306: checking whether to use ml_benchmarking configure:7316: result: no configure:7366: checking whether to use ml_superlu configure:7376: result: no configure:7391: checking whether to use ml_superlu2 configure:7401: result: no configure:7416: checking whether to use ml_superlu_dist configure:7426: result: no configure:7441: checking whether to use ml_metis configure:7451: result: no configure:7466: checking whether to use ml_parmetis2x configure:7476: result: no configure:7491: checking whether to use ml_parmetis3x configure:7501: result: no configure:7516: checking whether to use ml_arpack configure:7526: result: no configure:7541: checking whether to use ml_parpack configure:7551: result: no configure:7566: checking whether to use ml_parasails configure:7576: result: no configure:7591: checking whether to use ml_nox configure:7601: result: no configure:7624: checking whether to use ml_zoltan configure:7634: result: no configure:7657: checking whether to use ml_zoltan3 configure:7667: result: no configure:7690: checking whether to use petsc configure:7700: result: no configure:7734: checking whether to build optional epetra dependent code in ml configure:7744: result: no configure:7783: checking whether to build optional amesos dependent code in ml configure:7793: result: no configure:7844: checking whether to build optional ifpack dependent code in ml configure:7854: result: no configure:7893: checking whether to build optional teuchos dependent code in ml configure:7903: result: no configure:7944: checking whether to build optional aztecoo dependent code in ml configure:7954: result: no configure:7993: checking whether to build optional epetraext dependent code in ml configure:8003: result: no configure:8049: checking whether to build optional isorropia dependent code in ml configure:8059: result: no configure:8098: checking whether to build optional galeri dependent code in ml configure:8108: result: no configure:8165: checking whether to use ml-examples configure:8175: result: no configure:8199: checking whether to use tests configure:8209: result: no configure:8230: checking whether to use ml-tests configure:8240: result: no configure:8284: checking whether to use libcheck configure:8288: result: yes configure:8305: checking whether additional library search paths defined configure:8316: result: no configure:8324: checking whether additional include search paths defined configure:8335: result: no configure:8352: checking how to get verbose linking output from /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort configure:8362: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -MT -O2 -Qopenmp -fpp conftest.f >&5 configure:8362: $? = 0 configure:8380: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o conftest.exe -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -MT -O2 -Qopenmp -fpp -v conftest.f /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib ifort: command line warning #10006: ignoring unknown option '/v' configure:8380: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o conftest.exe -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -MT -O2 -Qopenmp -fpp -verbose conftest.f /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib ifort: command line warning #10006: ignoring unknown option '/verbose' configure:8380: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o conftest.exe -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -MT -O2 -Qopenmp -fpp --verbose conftest.f /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Attempting to create file: C:\Users\AliReza\AppData\Local\Temp\wfeC4B9.tmp ifort Intel(R) Visual Fortran Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 del C:\Users\AliReza\AppData\Local\Temp\wfeC4B9.tmp Attempting to create file: C:\Users\AliReza\AppData\Local\Temp\wfeC4E9.tmp ifort -MT -O2 -Qopenmp -fpp -IE:\PROGRA~4\INTELS~1\COMPIL~2\windows\mpi\intel64\include -MT -O2 -Qopenmp -fpp conftest.f E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mpi\intel64\lib\impi.lib -FeE:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.exe -link Intel(R) Visual Fortran Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 Copyright (C) 1985-2018 Intel Corporation. All rights reserved. Microsoft (R) Incremental Linker Version 14.15.26726.0 Copyright (C) Microsoft Corporation. All rights reserved. -out:E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.exe -subsystem:console -defaultlib:libiomp5md.lib -nodefaultlib:vcomp.lib -nodefaultlib:vcompd.lib conftest.obj E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mpi\intel64\lib\impi.lib del C:\Users\AliReza\AppData\Local\Temp\wfeC4E9.tmp configure:8463: result: --verbose configure:8465: checking for Fortran 77 libraries of /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort configure:8488: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o conftest.exe -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -MT -O2 -Qopenmp -fpp --verbose conftest.f /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Attempting to create file: C:\Users\AliReza\AppData\Local\Temp\wfeC758.tmp ifort Intel(R) Visual Fortran Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 del C:\Users\AliReza\AppData\Local\Temp\wfeC758.tmp Attempting to create file: C:\Users\AliReza\AppData\Local\Temp\wfeC778.tmp ifort -MT -O2 -Qopenmp -fpp -IE:\PROGRA~4\INTELS~1\COMPIL~2\windows\mpi\intel64\include -MT -O2 -Qopenmp -fpp conftest.f E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mpi\intel64\lib\impi.lib -FeE:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.exe -link Intel(R) Visual Fortran Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 Copyright (C) 1985-2018 Intel Corporation. All rights reserved. Microsoft (R) Incremental Linker Version 14.15.26726.0 Copyright (C) Microsoft Corporation. All rights reserved. -out:E:\cygwin64\home\alireza\petsc-3.9.3\arch-mswin-c-opt\externalpackages\git.ml\conftest.exe -subsystem:console -defaultlib:libiomp5md.lib -nodefaultlib:vcomp.lib -nodefaultlib:vcompd.lib conftest.obj E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mpi\intel64\lib\impi.lib del C:\Users\AliReza\AppData\Local\Temp\wfeC778.tmp configure:8684: result: -link configure:8701: checking for dummy main to link with Fortran 77 libraries configure:8735: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib -link >&5 conftest.c LINK : fatal error LNK1181: cannot open input file 'libink.obj' configure:8735: $? = 157 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_CSTDLIB 1 | #define HAVE_CSTDIO 1 | #define HAVE_CASSERT 1 | #define HAVE_CMATH 1 | #define HAVE_IOMANIP 1 | #define HAVE_IOSTREAM 1 | #define HAVE_STRING 1 | #define HAVE_MALLOC_H 1 | #define HAVE_NAMESPACES /**/ | #define HAVE_STL /**/ | #define HAVE_BOOL /**/ | #define HAVE_MUTABLE /**/ | #define HAVE_NEW_FOR_SCOPING /**/ | #define HAVE_STD_SPRINTF /**/ | #define HAVE_CFUNC /**/ | #define HAVE_ML_NEW_T_PE 1 | #define ML_BIG_INT int | #define HAVE_LIBCHECK /**/ | /* end confdefs.h. */ | | #ifdef F77_DUMMY_MAIN | | # ifdef __cplusplus | extern "C" | # endif | int F77_DUMMY_MAIN() { return 1; } | | #endif | int | main () | { | | ; | return 0; | } configure:8764: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib -link >&5 conftest.c LINK : fatal error LNK1181: cannot open input file 'libink.obj' configure:8764: $? = 157 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_CSTDLIB 1 | #define HAVE_CSTDIO 1 | #define HAVE_CASSERT 1 | #define HAVE_CMATH 1 | #define HAVE_IOMANIP 1 | #define HAVE_IOSTREAM 1 | #define HAVE_STRING 1 | #define HAVE_MALLOC_H 1 | #define HAVE_NAMESPACES /**/ | #define HAVE_STL /**/ | #define HAVE_BOOL /**/ | #define HAVE_MUTABLE /**/ | #define HAVE_NEW_FOR_SCOPING /**/ | #define HAVE_STD_SPRINTF /**/ | #define HAVE_CFUNC /**/ | #define HAVE_ML_NEW_T_PE 1 | #define ML_BIG_INT int | #define HAVE_LIBCHECK /**/ | /* end confdefs.h. */ | #define F77_DUMMY_MAIN MAIN__ | #ifdef F77_DUMMY_MAIN | | # ifdef __cplusplus | extern "C" | # endif | int F77_DUMMY_MAIN() { return 1; } | | #endif | int | main () | { | | ; | return 0; | } configure:8764: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib -link >&5 conftest.c LINK : fatal error LNK1181: cannot open input file 'libink.obj' configure:8764: $? = 157 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_CSTDLIB 1 | #define HAVE_CSTDIO 1 | #define HAVE_CASSERT 1 | #define HAVE_CMATH 1 | #define HAVE_IOMANIP 1 | #define HAVE_IOSTREAM 1 | #define HAVE_STRING 1 | #define HAVE_MALLOC_H 1 | #define HAVE_NAMESPACES /**/ | #define HAVE_STL /**/ | #define HAVE_BOOL /**/ | #define HAVE_MUTABLE /**/ | #define HAVE_NEW_FOR_SCOPING /**/ | #define HAVE_STD_SPRINTF /**/ | #define HAVE_CFUNC /**/ | #define HAVE_ML_NEW_T_PE 1 | #define ML_BIG_INT int | #define HAVE_LIBCHECK /**/ | /* end confdefs.h. */ | #define F77_DUMMY_MAIN MAIN_ | #ifdef F77_DUMMY_MAIN | | # ifdef __cplusplus | extern "C" | # endif | int F77_DUMMY_MAIN() { return 1; } | | #endif | int | main () | { | | ; | return 0; | } configure:8764: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib -link >&5 conftest.c LINK : fatal error LNK1181: cannot open input file 'libink.obj' configure:8764: $? = 157 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_CSTDLIB 1 | #define HAVE_CSTDIO 1 | #define HAVE_CASSERT 1 | #define HAVE_CMATH 1 | #define HAVE_IOMANIP 1 | #define HAVE_IOSTREAM 1 | #define HAVE_STRING 1 | #define HAVE_MALLOC_H 1 | #define HAVE_NAMESPACES /**/ | #define HAVE_STL /**/ | #define HAVE_BOOL /**/ | #define HAVE_MUTABLE /**/ | #define HAVE_NEW_FOR_SCOPING /**/ | #define HAVE_STD_SPRINTF /**/ | #define HAVE_CFUNC /**/ | #define HAVE_ML_NEW_T_PE 1 | #define ML_BIG_INT int | #define HAVE_LIBCHECK /**/ | /* end confdefs.h. */ | #define F77_DUMMY_MAIN __main | #ifdef F77_DUMMY_MAIN | | # ifdef __cplusplus | extern "C" | # endif | int F77_DUMMY_MAIN() { return 1; } | | #endif | int | main () | { | | ; | return 0; | } configure:8764: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib -link >&5 conftest.c LINK : fatal error LNK1181: cannot open input file 'libink.obj' configure:8764: $? = 157 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_CSTDLIB 1 | #define HAVE_CSTDIO 1 | #define HAVE_CASSERT 1 | #define HAVE_CMATH 1 | #define HAVE_IOMANIP 1 | #define HAVE_IOSTREAM 1 | #define HAVE_STRING 1 | #define HAVE_MALLOC_H 1 | #define HAVE_NAMESPACES /**/ | #define HAVE_STL /**/ | #define HAVE_BOOL /**/ | #define HAVE_MUTABLE /**/ | #define HAVE_NEW_FOR_SCOPING /**/ | #define HAVE_STD_SPRINTF /**/ | #define HAVE_CFUNC /**/ | #define HAVE_ML_NEW_T_PE 1 | #define ML_BIG_INT int | #define HAVE_LIBCHECK /**/ | /* end confdefs.h. */ | #define F77_DUMMY_MAIN MAIN | #ifdef F77_DUMMY_MAIN | | # ifdef __cplusplus | extern "C" | # endif | int F77_DUMMY_MAIN() { return 1; } | | #endif | int | main () | { | | ; | return 0; | } configure:8764: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib -link >&5 conftest.c LINK : fatal error LNK1181: cannot open input file 'libink.obj' configure:8764: $? = 157 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_CSTDLIB 1 | #define HAVE_CSTDIO 1 | #define HAVE_CASSERT 1 | #define HAVE_CMATH 1 | #define HAVE_IOMANIP 1 | #define HAVE_IOSTREAM 1 | #define HAVE_STRING 1 | #define HAVE_MALLOC_H 1 | #define HAVE_NAMESPACES /**/ | #define HAVE_STL /**/ | #define HAVE_BOOL /**/ | #define HAVE_MUTABLE /**/ | #define HAVE_NEW_FOR_SCOPING /**/ | #define HAVE_STD_SPRINTF /**/ | #define HAVE_CFUNC /**/ | #define HAVE_ML_NEW_T_PE 1 | #define ML_BIG_INT int | #define HAVE_LIBCHECK /**/ | /* end confdefs.h. */ | #define F77_DUMMY_MAIN _MAIN | #ifdef F77_DUMMY_MAIN | | # ifdef __cplusplus | extern "C" | # endif | int F77_DUMMY_MAIN() { return 1; } | | #endif | int | main () | { | | ; | return 0; | } configure:8764: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib -link >&5 conftest.c LINK : fatal error LNK1181: cannot open input file 'libink.obj' configure:8764: $? = 157 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_CSTDLIB 1 | #define HAVE_CSTDIO 1 | #define HAVE_CASSERT 1 | #define HAVE_CMATH 1 | #define HAVE_IOMANIP 1 | #define HAVE_IOSTREAM 1 | #define HAVE_STRING 1 | #define HAVE_MALLOC_H 1 | #define HAVE_NAMESPACES /**/ | #define HAVE_STL /**/ | #define HAVE_BOOL /**/ | #define HAVE_MUTABLE /**/ | #define HAVE_NEW_FOR_SCOPING /**/ | #define HAVE_STD_SPRINTF /**/ | #define HAVE_CFUNC /**/ | #define HAVE_ML_NEW_T_PE 1 | #define ML_BIG_INT int | #define HAVE_LIBCHECK /**/ | /* end confdefs.h. */ | #define F77_DUMMY_MAIN __MAIN | #ifdef F77_DUMMY_MAIN | | # ifdef __cplusplus | extern "C" | # endif | int F77_DUMMY_MAIN() { return 1; } | | #endif | int | main () | { | | ; | return 0; | } configure:8764: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib -link >&5 conftest.c LINK : fatal error LNK1181: cannot open input file 'libink.obj' configure:8764: $? = 157 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_CSTDLIB 1 | #define HAVE_CSTDIO 1 | #define HAVE_CASSERT 1 | #define HAVE_CMATH 1 | #define HAVE_IOMANIP 1 | #define HAVE_IOSTREAM 1 | #define HAVE_STRING 1 | #define HAVE_MALLOC_H 1 | #define HAVE_NAMESPACES /**/ | #define HAVE_STL /**/ | #define HAVE_BOOL /**/ | #define HAVE_MUTABLE /**/ | #define HAVE_NEW_FOR_SCOPING /**/ | #define HAVE_STD_SPRINTF /**/ | #define HAVE_CFUNC /**/ | #define HAVE_ML_NEW_T_PE 1 | #define ML_BIG_INT int | #define HAVE_LIBCHECK /**/ | /* end confdefs.h. */ | #define F77_DUMMY_MAIN main_ | #ifdef F77_DUMMY_MAIN | | # ifdef __cplusplus | extern "C" | # endif | int F77_DUMMY_MAIN() { return 1; } | | #endif | int | main () | { | | ; | return 0; | } configure:8764: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib -link >&5 conftest.c LINK : fatal error LNK1181: cannot open input file 'libink.obj' configure:8764: $? = 157 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_CSTDLIB 1 | #define HAVE_CSTDIO 1 | #define HAVE_CASSERT 1 | #define HAVE_CMATH 1 | #define HAVE_IOMANIP 1 | #define HAVE_IOSTREAM 1 | #define HAVE_STRING 1 | #define HAVE_MALLOC_H 1 | #define HAVE_NAMESPACES /**/ | #define HAVE_STL /**/ | #define HAVE_BOOL /**/ | #define HAVE_MUTABLE /**/ | #define HAVE_NEW_FOR_SCOPING /**/ | #define HAVE_STD_SPRINTF /**/ | #define HAVE_CFUNC /**/ | #define HAVE_ML_NEW_T_PE 1 | #define ML_BIG_INT int | #define HAVE_LIBCHECK /**/ | /* end confdefs.h. */ | #define F77_DUMMY_MAIN main__ | #ifdef F77_DUMMY_MAIN | | # ifdef __cplusplus | extern "C" | # endif | int F77_DUMMY_MAIN() { return 1; } | | #endif | int | main () | { | | ; | return 0; | } configure:8764: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o conftest.exe -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include conftest.c /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib -link >&5 conftest.c LINK : fatal error LNK1181: cannot open input file 'libink.obj' configure:8764: $? = 157 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "ml" | #define PACKAGE_TARNAME "ml" | #define PACKAGE_VERSION "6.2" | #define PACKAGE_STRING "ml 6.2" | #define PACKAGE_BUGREPORT "jhu at sandia.gov" | #define PACKAGE_URL "" | #define HAVE_MPI /**/ | #define HAVE_EXPORT_MAKEFILES /**/ | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_CSTDLIB 1 | #define HAVE_CSTDIO 1 | #define HAVE_CASSERT 1 | #define HAVE_CMATH 1 | #define HAVE_IOMANIP 1 | #define HAVE_IOSTREAM 1 | #define HAVE_STRING 1 | #define HAVE_MALLOC_H 1 | #define HAVE_NAMESPACES /**/ | #define HAVE_STL /**/ | #define HAVE_BOOL /**/ | #define HAVE_MUTABLE /**/ | #define HAVE_NEW_FOR_SCOPING /**/ | #define HAVE_STD_SPRINTF /**/ | #define HAVE_CFUNC /**/ | #define HAVE_ML_NEW_T_PE 1 | #define ML_BIG_INT int | #define HAVE_LIBCHECK /**/ | /* end confdefs.h. */ | #define F77_DUMMY_MAIN _main | #ifdef F77_DUMMY_MAIN | | # ifdef __cplusplus | extern "C" | # endif | int F77_DUMMY_MAIN() { return 1; } | | #endif | int | main () | { | | ; | return 0; | } configure:8780: result: unknown configure:8797: error: in `/home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml': configure:8799: error: linking to Fortran libraries from C fails See `config.log' for more details ## ---------------- ## ## Cache variables. ## ## ---------------- ## ac_cv_build=x86_64-unknown-cygwin ac_cv_c_compiler_gnu=no ac_cv_c_inline=inline ac_cv_c_var_func=yes ac_cv_cxx_bool=yes ac_cv_cxx_compiler_gnu=no ac_cv_cxx_have_stl=yes ac_cv_cxx_mutable=yes ac_cv_cxx_namespaces=yes ac_cv_cxx_new_for_scoping=yes ac_cv_cxx_std_sprintf1=yes ac_cv_cxx_std_sprintf2=yes ac_cv_cxx_std_sprintf=yes ac_cv_env_CCC_set= ac_cv_env_CCC_value= ac_cv_env_CC_set=set ac_cv_env_CC_value='/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl' ac_cv_env_CFLAGS_set=set ac_cv_env_CFLAGS_value='-O2 -MT -wd4996 -Qopenmp' ac_cv_env_CPPFLAGS_set=set ac_cv_env_CPPFLAGS_value=-I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include ac_cv_env_CXXCPP_set= ac_cv_env_CXXCPP_value= ac_cv_env_CXXFLAGS_set=set ac_cv_env_CXXFLAGS_value='-O2 -MT -wd4996 -Qopenmp -TP' ac_cv_env_CXX_set=set ac_cv_env_CXX_value='/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl' ac_cv_env_F77_set=set ac_cv_env_F77_value='/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort' ac_cv_env_FFLAGS_set=set ac_cv_env_FFLAGS_value='-MT -O2 -Qopenmp -fpp' ac_cv_env_LDFLAGS_set= ac_cv_env_LDFLAGS_value= ac_cv_env_LIBS_set= ac_cv_env_LIBS_value= ac_cv_env_MATLAB_EXE_set= ac_cv_env_MATLAB_EXE_value= ac_cv_env_MATLAB_set= ac_cv_env_MATLAB_value= ac_cv_env_build_alias_set= ac_cv_env_build_alias_value= ac_cv_env_host_alias_set= ac_cv_env_host_alias_value= ac_cv_env_target_alias_set= ac_cv_env_target_alias_value= ac_cv_exeext=.exe ac_cv_f77_compiler_gnu=no ac_cv_f77_dummy_main=unknown ac_cv_f77_libs=' -link ' ac_cv_fortran_dummy_main=unknown ac_cv_header_cassert=yes ac_cv_header_cmath=yes ac_cv_header_cstdio=yes ac_cv_header_cstdlib=yes ac_cv_header_inttypes_h=yes ac_cv_header_iomanip=yes ac_cv_header_iostream=yes ac_cv_header_malloc_h=yes ac_cv_header_memory_h=yes ac_cv_header_stdc=yes ac_cv_header_stdint_h=yes ac_cv_header_stdlib_h=yes ac_cv_header_string=yes ac_cv_header_string_h=yes ac_cv_header_strings_h=no ac_cv_header_sys_stat_h=yes ac_cv_header_sys_types_h=yes ac_cv_header_unistd_h=no ac_cv_host=x86_64-unknown-cygwin ac_cv_implicit_use_amesos=no ac_cv_implicit_use_aztecoo=no ac_cv_implicit_use_epetra=no ac_cv_implicit_use_epetraext=no ac_cv_implicit_use_galeri=no ac_cv_implicit_use_ifpack=no ac_cv_implicit_use_isorropia=no ac_cv_implicit_use_teuchos=no ac_cv_ml_using_amesos_default=no ac_cv_ml_using_aztecoo_default=no ac_cv_ml_using_epetra_default=no ac_cv_ml_using_epetraext_default=no ac_cv_ml_using_galeri_default=no ac_cv_ml_using_ifpack_default=no ac_cv_ml_using_isorropia_default=no ac_cv_ml_using_teuchos_default=no ac_cv_objext=o ac_cv_path_EGREP='/usr/bin/grep -E' ac_cv_path_GREP=/usr/bin/grep ac_cv_path_install='/usr/bin/install -c' ac_cv_path_mkdir=/usr/bin/mkdir ac_cv_prog_AWK=gawk ac_cv_prog_CXXCPP='/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E' ac_cv_prog_HAVE_PERL=yes ac_cv_prog_ac_ct_RANLIB=ranlib ac_cv_prog_cc_c89= ac_cv_prog_cc_g=yes ac_cv_prog_cxx_g=yes ac_cv_prog_f77_g=yes ac_cv_prog_f77_v=--verbose ac_cv_prog_make__usr_bin_make_set=yes ac_cv_target=x86_64-unknown-cygwin ac_cv_use_amesos=no ac_cv_use_aztecoo=no ac_cv_use_epetra=no ac_cv_use_epetraext=no ac_cv_use_examples=yes ac_cv_use_export_makefiles=yes ac_cv_use_galeri=no ac_cv_use_gnumake=no ac_cv_use_ifpack=no ac_cv_use_isorropia=no ac_cv_use_libcheck=yes ac_cv_use_ml_arpack=no ac_cv_use_ml_aztec2_1=no ac_cv_use_ml_benchmarking=no ac_cv_use_ml_complex_maxwell=no ac_cv_use_ml_enrich=no ac_cv_use_ml_examples=no ac_cv_use_ml_flops=no ac_cv_use_ml_memory_checking=no ac_cv_use_ml_metis=no ac_cv_use_ml_multiple_rhs=no ac_cv_use_ml_newtpe=yes ac_cv_use_ml_nox=no ac_cv_use_ml_parasails=no ac_cv_use_ml_parmetis2x=no ac_cv_use_ml_parmetis3x=no ac_cv_use_ml_parpack=no ac_cv_use_ml_superlu2=no ac_cv_use_ml_superlu=no ac_cv_use_ml_superlu_dist=no ac_cv_use_ml_tests=no ac_cv_use_ml_timing=no ac_cv_use_ml_zoltan3=no ac_cv_use_ml_zoltan=no ac_cv_use_petsc=no ac_cv_use_tests=no ac_cv_use_teuchos=no am_cv_CC_dependencies_compiler_type=msvc7 am_cv_CXX_dependencies_compiler_type=msvc7 am_cv_make_support_nested_variables=yes am_cv_prog_cc_c_o=yes am_cv_prog_tar_ustar=gnutar ## ----------------- ## ## Output variables. ## ## ----------------- ## ACLOCAL='${SHELL} /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml/config/missing aclocal-1.15' ALTERNATE_AR='' AMDEPBACKSLASH='\' AMDEP_FALSE='#' AMDEP_TRUE='' AMTAR='$${TAR-tar}' AM_BACKSLASH='\' AM_DEFAULT_V='$(AM_DEFAULT_VERBOSITY)' AM_DEFAULT_VERBOSITY='1' AM_V='$(V)' AUTOCONF='${SHELL} /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml/config/missing autoconf' AUTOHEADER='${SHELL} /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml/config/missing autoheader' AUTOMAKE='${SHELL} /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml/config/missing automake-1.15' AWK='gawk' BLAS_LIBS='' BUILD_MATLAB_FALSE='' BUILD_MATLAB_TRUE='' BUILD_ML_MATLAB_FALSE='' BUILD_ML_MATLAB_TRUE='' BUILD_TESTS_FALSE='' BUILD_TESTS_TRUE='#' CC='/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl' CCDEPMODE='depmode=msvc7' CFLAGS='-O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp' CPPFLAGS='-I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include' CXX='/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl' CXXCPP='/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E' CXXDEPMODE='depmode=msvc7' CXXFLAGS='-O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP' CYGPATH_W='cygpath -w' DEFS='' DEPDIR='.deps' ECHO_C='' ECHO_N='-n' ECHO_T='' EGREP='/usr/bin/grep -E' EXEEXT='.exe' F77='/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort' FFLAGS='-MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -MT -O2 -Qopenmp -fpp' FLIBS=' -link ' GREP='/usr/bin/grep' HAVE_MPI_FALSE='#' HAVE_MPI_TRUE='' HAVE_PERL='yes' INSTALL_DATA='${INSTALL} -m 644' INSTALL_PROGRAM='${INSTALL}' INSTALL_SCRIPT='${INSTALL}' INSTALL_STRIP_PROGRAM='$(install_sh) -c -s' LAPACK_LIBS='' LDFLAGS='' LIBOBJS='' LIBS='/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib ' LTLIBOBJS='' MAINT='#' MAINTAINER_MODE_FALSE='' MAINTAINER_MODE_TRUE='#' MAKEINFO='${SHELL} /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml/config/missing makeinfo' MATLAB='' MATLAB_EXE='' MATLAB_ROOT='' MATLAB_ROOT_USE_FALSE='' MATLAB_ROOT_USE_TRUE='' MATLAB_USE_FALSE='' MATLAB_USE_TRUE='' MEX='' MEXEXT='' MEXEXT_VALUE='' MKDIR_P='/usr/bin/mkdir -p' ML_BENCHMARKING_FALSE='' ML_BENCHMARKING_TRUE='#' ML_BUILD_DIRECTORY='/home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml' ML_BUILD_EXAMPLES_FALSE='' ML_BUILD_EXAMPLES_TRUE='#' ML_CFUNC_FALSE='#' ML_CFUNC_TRUE='' ML_MATLAB_INCLUDES='' ML_STANDALONE_MODE_FALSE='#' ML_STANDALONE_MODE_TRUE='' ML_USING_AMESOS_FALSE='' ML_USING_AMESOS_TRUE='#' ML_USING_AZTECOO_FALSE='' ML_USING_AZTECOO_TRUE='#' ML_USING_EPETRAEXT_FALSE='' ML_USING_EPETRAEXT_TRUE='#' ML_USING_EPETRA_FALSE='' ML_USING_EPETRA_TRUE='#' ML_USING_GALERI_FALSE='' ML_USING_GALERI_TRUE='#' ML_USING_IFPACK_FALSE='' ML_USING_IFPACK_TRUE='#' ML_USING_ISORROPIA_FALSE='' ML_USING_ISORROPIA_TRUE='#' ML_USING_NOX_FALSE='' ML_USING_NOX_TRUE='#' ML_USING_TEUCHOS_FALSE='' ML_USING_TEUCHOS_TRUE='#' ML_USING_ZOLTAN_FALSE='' ML_USING_ZOLTAN_TRUE='#' MPI_CC_EXISTS='' MPI_CXX='' MPI_CXX_EXISTS='' MPI_F77_EXISTS='' MPI_TEMP_CXX='' OBJEXT='o' PACKAGE='ml' PACKAGE_BUGREPORT='jhu at sandia.gov' PACKAGE_NAME='ml' PACKAGE_STRING='ml 6.2' PACKAGE_TARNAME='ml' PACKAGE_URL='' PACKAGE_VERSION='6.2' PATH_SEPARATOR=':' PERL_EXE='perl' RANLIB='ranlib' SET_MAKE='' SHELL='/bin/sh' STRIP='' SUB_EXAMPLE_FALSE='' SUB_EXAMPLE_TRUE='#' SUB_TEST_FALSE='' SUB_TEST_TRUE='#' TRILINOS_TEMPLATE_OBJS='' USE_ALTERNATE_AR_FALSE='' USE_ALTERNATE_AR_TRUE='#' USING_EXPORT_MAKEFILES_FALSE='#' USING_EXPORT_MAKEFILES_TRUE='' USING_GNUMAKE_FALSE='' USING_GNUMAKE_TRUE='#' USING_PERL_FALSE='#' USING_PERL_TRUE='' VERSION='6.2' ac_aux_dir='config' ac_ct_CC='' ac_ct_CXX='' ac_ct_F77='' am__EXEEXT_FALSE='' am__EXEEXT_TRUE='' am__fastdepCC_FALSE='' am__fastdepCC_TRUE='#' am__fastdepCXX_FALSE='' am__fastdepCXX_TRUE='#' am__include='include' am__isrc='' am__leading_dot='.' am__nodep='_no' am__quote='' am__tar='tar --format=ustar -chf - "$$tardir"' am__untar='tar -xf -' bindir='${exec_prefix}/bin' build='x86_64-unknown-cygwin' build_alias='' build_cpu='x86_64' build_os='cygwin' build_vendor='unknown' datadir='${datarootdir}' datarootdir='${prefix}/share' docdir='${datarootdir}/doc/${PACKAGE_TARNAME}' dvidir='${docdir}' exec_prefix='NONE' host='x86_64-unknown-cygwin' host_alias='' host_cpu='x86_64' host_os='cygwin' host_vendor='unknown' htmldir='${docdir}' includedir='${prefix}/include' infodir='${datarootdir}/info' install_sh='${SHELL} /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml/config/install-sh' libdir='/home/alireza/Petsc393Install/lib' libexecdir='${exec_prefix}/libexec' localedir='${datarootdir}/locale' localstatedir='${prefix}/var' mandir='${datarootdir}/man' mkdir_p='$(MKDIR_P)' oldincludedir='/usr/include' pdfdir='${docdir}' prefix='/home/alireza/Petsc393Install' program_transform_name='s,x,x,' psdir='${docdir}' sbindir='${exec_prefix}/sbin' sharedstatedir='${prefix}/com' sysconfdir='${prefix}/etc' target='x86_64-unknown-cygwin' target_alias='' target_cpu='x86_64' target_os='cygwin' target_vendor='unknown' ## ----------- ## ## confdefs.h. ## ## ----------- ## /* confdefs.h */ #define PACKAGE_NAME "ml" #define PACKAGE_TARNAME "ml" #define PACKAGE_VERSION "6.2" #define PACKAGE_STRING "ml 6.2" #define PACKAGE_BUGREPORT "jhu at sandia.gov" #define PACKAGE_URL "" #define HAVE_MPI /**/ #define HAVE_EXPORT_MAKEFILES /**/ #define STDC_HEADERS 1 #define HAVE_SYS_TYPES_H 1 #define HAVE_SYS_STAT_H 1 #define HAVE_STDLIB_H 1 #define HAVE_STRING_H 1 #define HAVE_MEMORY_H 1 #define HAVE_INTTYPES_H 1 #define HAVE_STDINT_H 1 #define HAVE_CSTDLIB 1 #define HAVE_CSTDIO 1 #define HAVE_CASSERT 1 #define HAVE_CMATH 1 #define HAVE_IOMANIP 1 #define HAVE_IOSTREAM 1 #define HAVE_STRING 1 #define HAVE_MALLOC_H 1 #define HAVE_NAMESPACES /**/ #define HAVE_STL /**/ #define HAVE_BOOL /**/ #define HAVE_MUTABLE /**/ #define HAVE_NEW_FOR_SCOPING /**/ #define HAVE_STD_SPRINTF /**/ #define HAVE_CFUNC /**/ #define HAVE_ML_NEW_T_PE 1 #define ML_BIG_INT int #define HAVE_LIBCHECK /**/ configure: exit 1 -------------- next part -------------- Pushing language C Popping language C Pushing language CUDA Popping language CUDA Pushing language Cxx Popping language Cxx Pushing language FC Popping language FC ================================================================================ ================================================================================ Starting configure run at Thu, 16 Aug 2018 11:12:16 +0430 Configure Options: --configModules=PETSc.Configure --optionsModule=config.compilerOptions --prefix=/home/alireza/Petsc393Install --download-ml=1 --download-hypre ?with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debugging=0 --with-blaslapack-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 -Qopenmp" Working directory: /home/alireza/petsc-3.9.3 Machine platform: ('CYGWIN_NT-6.1', 'AliReza-PC', '2.10.0(0.325/5/3)', '2018-02-02 15:16', 'x86_64', '') Python version: 2.7.14 (default, Oct 31 2017, 21:12:13) [GCC 6.4.0] ================================================================================ Pushing language C Popping language C Pushing language CUDA Popping language CUDA Pushing language Cxx Popping language Cxx Pushing language FC Popping language FC ================================================================================ TEST configureExternalPackagesDir from config.framework(/home/alireza/petsc-3.9.3/config/BuildSystem/config/framework.py:836) TESTING: configureExternalPackagesDir from config.framework(config/BuildSystem/config/framework.py:836) ================================================================================ TEST configureDebuggers from config.utilities.debuggers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/debuggers.py:22) TESTING: configureDebuggers from config.utilities.debuggers(config/BuildSystem/config/utilities/debuggers.py:22) Find a default debugger and determine its arguments Checking for program /usr/bin/gdb...found Defined make macro "GDB" to "/usr/bin/gdb" Checking for program /usr/bin/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/bin/intel64/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/compiler/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.15.26726/bin/HostX64/x64/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/VC/VCPackages/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/TypeScript/3.0/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TestWindow/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TeamFoundation/Team Explorer/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/Roslyn/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/x64/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/x64/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/Windows/v10.0A/bin/NETFX 4.6.1 Tools/x64/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/HTML Help Workshop/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/10.0.17134.0/x64/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/x64/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/dbx...not found Checking for program /cygdrive/c/Windows/Microsoft.NET/Framework64/v4.0.30319/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/Tools/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/gdb/intel64/bin/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/libipt/intel64/lib/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/ipp/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/daal/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/tbb/vc_mt/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Oracle/Java/javapath/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries_2018.3.210/windows/mpi/intel64/bin/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/mpirt/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/mpirt/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/compiler/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/compiler/dbx...not found Checking for program /cygdrive/e/Python37/Scripts/dbx...not found Checking for program /cygdrive/e/Python37/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/mpi/2018.1.156/intel64/bin/dbx...not found Checking for program /cygdrive/c/Program Files/Microsoft MPI/Bin/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI-RT/4.1.3.045/em64t/bin/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/CMG/CMGJobService/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.3.050/intel64/bin/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/mpirt/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/mpirt/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/compiler/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/compiler/dbx...not found Checking for program /cygdrive/c/ProgramData/Oracle/Java/javapath/dbx...not found Checking for program /cygdrive/c/Python27/dbx...not found Checking for program /cygdrive/c/Python27/Scripts/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/bin/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.2.044/intel64/bin/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Composer XE 2015/bin/ia32/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86_64/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86/dbx...not found Checking for program /cygdrive/c/Progra/dbx...not found Checking for program /cygdrive/c/Windows/System32/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft Visual Studio 14.0/Common7/IDE/dbx...not found Checking for program /cygdrive/e/Program Files/PuTTY/dbx...not found Checking for program /cygdrive/c/ecl/HOME/dbx...not found Checking for program /cygdrive/c/ecl/MACROS/dbx...not found Checking for program /cygdrive/e/Program Files/CMake/bin/dbx...not found Checking for program /cygdrive/e/ecl/HOME/dbx...not found Checking for program /cygdrive/e/ecl/MACROS/dbx...not found Checking for program /cygdrive/c/Program Files/dotnet/dbx...not found Checking for program /cygdrive/c/Program Files/Microsoft SQL Server/130/Tools/Binn/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.14.26428/bin/Hostx64/x64/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/IncrediBuild/dbx...not found Checking for program /cygdrive/e/Python36/Scripts/dbx...not found Checking for program /cygdrive/e/Python36/dbx...not found Checking for program /cygdrive/c/Users/AliReza/.dnx/bin/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/dll/dbx...not found Checking for program /cygdrive/c/Program Files (x86)/SSH Communications Security/SSH Secure Shell/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/CMake/bin/dbx...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/Ninja/dbx...not found Checking for program /usr/bin/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/bin/intel64/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/compiler/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.15.26726/bin/HostX64/x64/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/VC/VCPackages/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/TypeScript/3.0/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TestWindow/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TeamFoundation/Team Explorer/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/Roslyn/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/x64/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/x64/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/Windows/v10.0A/bin/NETFX 4.6.1 Tools/x64/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/HTML Help Workshop/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/10.0.17134.0/x64/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/x64/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/xdb...not found Checking for program /cygdrive/c/Windows/Microsoft.NET/Framework64/v4.0.30319/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/Tools/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/gdb/intel64/bin/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/libipt/intel64/lib/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/ipp/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/daal/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/tbb/vc_mt/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Oracle/Java/javapath/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries_2018.3.210/windows/mpi/intel64/bin/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/mpirt/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/mpirt/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/compiler/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/compiler/xdb...not found Checking for program /cygdrive/e/Python37/Scripts/xdb...not found Checking for program /cygdrive/e/Python37/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/mpi/2018.1.156/intel64/bin/xdb...not found Checking for program /cygdrive/c/Program Files/Microsoft MPI/Bin/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI-RT/4.1.3.045/em64t/bin/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/CMG/CMGJobService/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.3.050/intel64/bin/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/mpirt/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/mpirt/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/compiler/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/compiler/xdb...not found Checking for program /cygdrive/c/ProgramData/Oracle/Java/javapath/xdb...not found Checking for program /cygdrive/c/Python27/xdb...not found Checking for program /cygdrive/c/Python27/Scripts/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/bin/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.2.044/intel64/bin/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Composer XE 2015/bin/ia32/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86_64/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86/xdb...not found Checking for program /cygdrive/c/Progra/xdb...not found Checking for program /cygdrive/c/Windows/System32/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft Visual Studio 14.0/Common7/IDE/xdb...not found Checking for program /cygdrive/e/Program Files/PuTTY/xdb...not found Checking for program /cygdrive/c/ecl/HOME/xdb...not found Checking for program /cygdrive/c/ecl/MACROS/xdb...not found Checking for program /cygdrive/e/Program Files/CMake/bin/xdb...not found Checking for program /cygdrive/e/ecl/HOME/xdb...not found Checking for program /cygdrive/e/ecl/MACROS/xdb...not found Checking for program /cygdrive/c/Program Files/dotnet/xdb...not found Checking for program /cygdrive/c/Program Files/Microsoft SQL Server/130/Tools/Binn/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.14.26428/bin/Hostx64/x64/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/IncrediBuild/xdb...not found Checking for program /cygdrive/e/Python36/Scripts/xdb...not found Checking for program /cygdrive/e/Python36/xdb...not found Checking for program /cygdrive/c/Users/AliReza/.dnx/bin/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/dll/xdb...not found Checking for program /cygdrive/c/Program Files (x86)/SSH Communications Security/SSH Secure Shell/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/CMake/bin/xdb...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/Ninja/xdb...not found Executing: uname -s stdout: CYGWIN_NT-6.1 Defined make macro "DSYMUTIL" to "true" Defined "USE_GDB_DEBUGGER" to "1" ================================================================================ TEST configureGit from config.sourceControl(/home/alireza/petsc-3.9.3/config/BuildSystem/config/sourceControl.py:24) TESTING: configureGit from config.sourceControl(config/BuildSystem/config/sourceControl.py:24) Find the Git executable Checking for program /usr/bin/git...found Defined make macro "GIT" to "git" Executing: git --version stdout: git version 2.17.0 ================================================================================ TEST configureMercurial from config.sourceControl(/home/alireza/petsc-3.9.3/config/BuildSystem/config/sourceControl.py:35) TESTING: configureMercurial from config.sourceControl(config/BuildSystem/config/sourceControl.py:35) Find the Mercurial executable Checking for program /usr/bin/hg...found Defined make macro "HG" to "hg" Executing: hg version -q stdout: Mercurial Distributed SCM (version 4.3.2) ================================================================================ TEST configureCLanguage from PETSc.options.languages(/home/alireza/petsc-3.9.3/config/PETSc/options/languages.py:27) TESTING: configureCLanguage from PETSc.options.languages(config/PETSc/options/languages.py:27) Choose whether to compile the PETSc library using a C or C++ compiler C language is C Defined "CLANGUAGE_C" to "1" ================================================================================ TEST configureDirectories from PETSc.options.petscdir(/home/alireza/petsc-3.9.3/config/PETSc/options/petscdir.py:23) TESTING: configureDirectories from PETSc.options.petscdir(config/PETSc/options/petscdir.py:23) Checks PETSC_DIR and sets if not set Version Information: #define PETSC_VERSION_RELEASE 1 #define PETSC_VERSION_MAJOR 3 #define PETSC_VERSION_MINOR 9 #define PETSC_VERSION_SUBMINOR 3 #define PETSC_VERSION_PATCH 0 #define PETSC_VERSION_DATE "Jul, 02, 2018" #define PETSC_VERSION_GIT "v3.9.3" #define PETSC_VERSION_DATE_GIT "2018-07-02 10:58:05 -0500" #define PETSC_VERSION_EQ(MAJOR,MINOR,SUBMINOR) \ #define PETSC_VERSION_ PETSC_VERSION_EQ #define PETSC_VERSION_LT(MAJOR,MINOR,SUBMINOR) \ #define PETSC_VERSION_LE(MAJOR,MINOR,SUBMINOR) \ #define PETSC_VERSION_GT(MAJOR,MINOR,SUBMINOR) \ #define PETSC_VERSION_GE(MAJOR,MINOR,SUBMINOR) \ ================================================================================ TEST getDatafilespath from PETSc.options.dataFilesPath(/home/alireza/petsc-3.9.3/config/PETSc/options/dataFilesPath.py:29) TESTING: getDatafilespath from PETSc.options.dataFilesPath(config/PETSc/options/dataFilesPath.py:29) Checks what DATAFILESPATH should be ================================================================================ TEST configureInstallationMethod from PETSc.options.petscclone(/home/alireza/petsc-3.9.3/config/PETSc/options/petscclone.py:20) TESTING: configureInstallationMethod from PETSc.options.petscclone(config/PETSc/options/petscclone.py:20) This is a tarball installation ================================================================================ TEST configureArchitecture from PETSc.options.arch(/home/alireza/petsc-3.9.3/config/PETSc/options/arch.py:36) TESTING: configureArchitecture from PETSc.options.arch(config/PETSc/options/arch.py:36) Checks PETSC_ARCH and sets if not set ================================================================================ TEST setInstallDir from PETSc.options.installDir(/home/alireza/petsc-3.9.3/config/PETSc/options/installDir.py:36) TESTING: setInstallDir from PETSc.options.installDir(config/PETSc/options/installDir.py:36) setup installDir to either prefix or if that is not set to PETSC_DIR/PETSC_ARCH Defined make macro "PREFIXDIR" to "/home/alireza/Petsc393Install" ================================================================================ TEST saveReconfigure from PETSc.options.installDir(/home/alireza/petsc-3.9.3/config/PETSc/options/installDir.py:80) TESTING: saveReconfigure from PETSc.options.installDir(config/PETSc/options/installDir.py:80) ================================================================================ TEST cleanInstallDir from PETSc.options.installDir(/home/alireza/petsc-3.9.3/config/PETSc/options/installDir.py:73) TESTING: cleanInstallDir from PETSc.options.installDir(config/PETSc/options/installDir.py:73) ================================================================================ TEST configureInstallDir from PETSc.options.installDir(/home/alireza/petsc-3.9.3/config/PETSc/options/installDir.py:57) TESTING: configureInstallDir from PETSc.options.installDir(config/PETSc/options/installDir.py:57) Makes installDir subdirectories if it does not exist for both prefix install location and PETSc work install location Changed persistence directory to /home/alireza/petsc-3.9.3/arch-mswin-c-opt/lib/petsc/conf ================================================================================ TEST restoreReconfigure from PETSc.options.installDir(/home/alireza/petsc-3.9.3/config/PETSc/options/installDir.py:93) TESTING: restoreReconfigure from PETSc.options.installDir(config/PETSc/options/installDir.py:93) ================================================================================ TEST setExternalPackagesDir from PETSc.options.externalpackagesdir(/home/alireza/petsc-3.9.3/config/PETSc/options/externalpackagesdir.py:15) TESTING: setExternalPackagesDir from PETSc.options.externalpackagesdir(config/PETSc/options/externalpackagesdir.py:15) ================================================================================ TEST cleanExternalpackagesDir from PETSc.options.externalpackagesdir(/home/alireza/petsc-3.9.3/config/PETSc/options/externalpackagesdir.py:22) TESTING: cleanExternalpackagesDir from PETSc.options.externalpackagesdir(config/PETSc/options/externalpackagesdir.py:22) ================================================================================ TEST printEnvVariables from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1633) TESTING: printEnvVariables from config.setCompilers(config/BuildSystem/config/setCompilers.py:1633) **** printenv **** VCToolsRedistDir=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Redist\MSVC\14.15.26706\ LIB=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl\lib\intel64_win;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\lib\intel64_win;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\lib;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\lib\intel64;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\lib\intel64_win;e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.15.26726\ATLMFC\lib\x64;e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.15.26726\lib\x64;C:\Program Files (x86)\Windows Kits\NETFXSDK\4.6.1\lib\um\x64;C:\Program Files (x86)\Windows Kits\10\lib\10.0.17134.0\ucrt\x64;C:\Program Files (x86)\Windows Kits\10\lib\10.0.17134.0\um\x64;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mpi\intel64\bin\..\..\intel64\lib;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\ipp\lib\intel64;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl\lib\intel64_win;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\lib\intel64_win;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\lib\intel64\vc_mt;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\lib\intel64\vc_mt;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\daal\lib\intel64_win;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\lib\intel64_win\vc_mt; TBBROOT=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\.. COMPUTERNAME=ALIREZA-PC SCRIPT_NAME=compilervars_arch.bat SYSTEMROOT=C:\Windows WIN_TITLE_ARCH=Intel(R) 64 PRODUCT_NAME=Intel Compiler 18.0 Update 3 VSCMD_VER=15.8.0 PSTL_TARGET_VS=all WindowsSDK_ExecutablePath_x86=C:\Program Files (x86)\Microsoft SDKs\Windows\v10.0A\bin\NETFX 4.6.1 Tools\ CommonProgramFiles(x86)=C:\Program Files (x86)\Common Files INTELGTDEBUGGERROOT=E:\Program Files (x86)\IntelSWTools\debugger_2018\gdb\intel64_igfx\ FrameworkVersion64=v4.0.30319 ProgramFiles(x86)=C:\Program Files (x86) VCToolsInstallDir=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.15.26726\ include=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl\include\intel64\lp64;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\include\intel64;e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.15.26726\ATLMFC\include;e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.15.26726\include;C:\Program Files (x86)\Windows Kits\NETFXSDK\4.6.1\include\um;C:\Program Files (x86)\Windows Kits\10\include\10.0.17134.0\ucrt;C:\Program Files (x86)\Windows Kits\10\include\10.0.17134.0\shared;C:\Program Files (x86)\Windows Kits\10\include\10.0.17134.0\um;C:\Program Files (x86)\Windows Kits\10\include\10.0.17134.0\winrt;C:\Program Files (x86)\Windows Kits\10\include\10.0.17134.0\cppwinrt;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mpi\intel64\bin\..\..\intel64\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\ipp\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\pstl\bin\..\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\daal\include;C:\Program Files (x86)\Intel\Trace Analyzer and Collector\9.0.2.045\include EXECIGNORE=*.dll NDK_DIR="" DNX_HOME=%USERPROFILE%\.dnx COMSPEC=C:\Windows\system32\cmd.exe windows_tracing_logfile=C:\BVTBin\Tests\installpackage\csilogfile.log MSMPI_LIB64=C:\Program Files (x86)\Microsoft SDKs\MPI\Lib\x64\ ARCH_PATH=intel64 VCToolsVersion=14.15.26726 HOMEPATH=\Users\AliReza SLBSLS_LICENSE_FILE=@localhost; TARGET_ARCH=intel64 ICPP_COMPILER18=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries_2018.3.210\windows\ WindowsSDKVersion=10.0.17134.0\ __DOTNET_ADD_64BIT=1 HOMEDRIVE=C: MKLROOT=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl FrameworkVersion=v4.0.30319 SYSTEMDRIVE=C: INTEL_LICENSE_FILE=C:\Program Files (x86)\Common Files\\Intel\Licenses;C:\Program Files (x86)\Common Files\Intel\Licenses PROCESSOR_LEVEL=6 OS=Windows_NT __MS_VC_INSTALL_PATH=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.15.26726\ MSVS_VAR_SCRIPT="e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Auxiliary\Build\vcvarsall.bat" TARGET_VS=vs2017 LSDEFAULTDIR=C:\Program Files (x86)\CMG\SECURE WindowsSdkBinPath=C:\Program Files (x86)\Windows Kits\10\bin\ Platform=x64 CPATH=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\ipp\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\pstl\bin\..\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\daal\include; CommandPromptType=Native VS2017INSTALLDIR=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise HOME=/cygdrive/c/Users/AliReza/ IFORT_COMPILER18=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries_2018.3.210\windows\ TBB_CXX=icl.exe Framework40Version=v4.0 TBB_TARGET_ARCH=intel64 TEMP=/cygdrive/c/Users/AliReza/AppData/Local/Temp SHLVL=2 VTUNE_AMPLIFIER_2018_DIR=E:\Program Files (x86)\IntelSWTools\VTune Amplifier 2018\ MIC_LD_LIBRARY_PATH=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\lib\mic;C:\Program Files (x86)\Common Files\Intel\Shared Libraries\compiler\lib\intel64_win_mic DevEnvDir=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\Common7\IDE\ VSCMD_ARG_app_plat=Desktop WindowsSdkDir=C:\Program Files (x86)\Windows Kits\10\ ROOT=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows LOGONSERVER=\\ALIREZA-PC C_TARGET_ARCH=intel64 CLASSPATH=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\daal\lib\daal.jar; ALLUSERSPROFILE=C:\ProgramData MSVS_VAR_SCRIPT_DIR=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Auxiliary\Build ROOT_ROOT_NAME=windows KMP_DUPLICATE_LIB_OK=TRUE SESSIONNAME=Console PKG_CONFIG_PATH=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl\bin\pkgconfig;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl\bin\pkgconfig; _=./configure LIBRARY_PATH=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\ipp\lib\intel64;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\..\..\linux\tbb\lib\intel64\gcc4.7;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\..\..\linux\tbb\lib\intel64\gcc4.7; APPDATA=C:\Users\AliReza\AppData\Roaming INSPECTOR_2018_DIR=E:\Program Files (x86)\IntelSWTools\Inspector 2018\ PUBLIC=C:\Users\Public HTMLHelpDir=C:\Program Files (x86)\HTML Help Workshop __VSCMD_PREINIT_INCLUDE=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mpi\intel64\bin\..\..\intel64\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\ipp\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mkl\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\pstl\bin\..\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\include;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\daal\include;C:\Program Files (x86)\Intel\Trace Analyzer and Collector\9.0.2.045\include TBB_BIN_DIR=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\ I_MPI_ROOT=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mpi\intel64\bin\..\.. TMP=/cygdrive/c/Users/AliReza/AppData/Local/Temp PSModulePath=C:\Windows\system32\WindowsPowerShell\v1.0\Modules\ VSCMD_ARG_TGT_ARCH=x64 USERDOMAIN=AliReza-PC PRODUCT_NAME_FULL=Intel(R) Compiler 18.0 Update 3 (package 210) COMMONPROGRAMFILES=C:\Program Files\Common Files IPPROOT=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\ipp VBOX_MSI_INSTALL_PATH=C:\Program Files\Oracle\VirtualBox\ VSTO_SUPPRESSDISPLAYALERTS=0 LD_LIBRARY_PATH=/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/linux/compiler/lib/intel64_lin:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/linux/tbb/lib/intel64/gcc4.7:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/linux/tbb/lib/intel64/gcc4.7:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/linux/daal/lib/intel64_lin:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/linux/tbb/lib/intel64_lin/gcc4.7:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/linux/tbb/lib/intel64_lin/gcc4.4 WindowsLibPath=C:\Program Files (x86)\Windows Kits\10\UnionMetadata\10.0.17134.0;C:\Program Files (x86)\Windows Kits\10\References\10.0.17134.0 MIC_LIBRARY_PATH=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\lib\mic; ProgramData=C:\ProgramData PROCESSOR_ARCHITECTURE=AMD64 VS150COMNTOOLS=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\Common7\Tools\ VisualStudioVersion=15.0 __VSCMD_PREINIT_PATH=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\mpi\intel64\bin\..\..\intel64\bin;E:\Program Files (x86)\IntelSWTools\debugger_2018\bin\\..\gdb\intel64\bin;E:\Program Files (x86)\IntelSWTools\debugger_2018\bin\..\libipt\intel64\lib;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\ipp\..\redist\intel64\ipp;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\redist\intel64_win\mkl;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\redist\intel64_win\compiler;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\..\redist\intel64\tbb\vc_mt;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\tbb\bin\..\..\redist\intel64\tbb\vc_mt;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\redist\intel64_win\daal;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\redist\intel64_win\tbb\vc_mt;C:\Program Files (x86)\Common Files\Oracle\Java\javapath;E:\Program Files (x86)\IntelSWTools\compilers_and_libraries_2018.3.210\windows\mpi\intel64\bin;C:\Program Files (x86)\Common Files\Intel\Shared Libraries\redist\intel64_win\mpirt;C:\Program Files (x86)\Common Files\Intel\Shared Libraries\redist\ia32_win\mpirt;C:\Program Files (x86)\Common Files\Intel\Shared Libraries\redist\intel64_win\compiler;C:\Program Files (x86)\Common Files\Intel\Shared Libraries\redist\ia32_win\compiler;E:\Python37\Scripts\;E:\Python37\;E:\Program Files (x86)\IntelSWTools\mpi\2018.1.156\intel64\bin;C:\Program Files\Microsoft MPI\Bin\;C:\Program Files (x86)\Intel\MPI-RT\4.1.3.045\em64t\bin;C:\Program Files (x86)\CMG\CMGJobService;C:\Program Files (x86)\Intel\MPI\5.0.3.050\intel64\bin;C:\Program Files (x86)\Common Files\Intel\Shared Libraries\redist\intel64\mpirt;C:\Program Files (x86)\Common Files\Intel\Shared Libraries\redist\ia32\mpirt;C:\Program Files (x86)\Common Files\Intel\Shared Libraries\redist\intel64\compiler;C:\Program Files (x86)\Common Files\Intel\Shared Libraries\redist\ia32\compiler;C:\ProgramData\Oracle\Java\javapath;C:\Python27;C:\Python27\Scripts;C:\Program Files (x86)\Intel\Trace Analyzer and Collector\9.0.2.045\bin;C:\Program Files (x86)\Intel\MPI\5.0.2.044\intel64\bin;C:\Program Files (x86)\Intel\Composer XE 2015\bin\ia32;C:\Program Files (x86)\AMD APP SDK\2.9\bin\x86_64;C:\Program Files (x86)\AMD APP SDK\2.9\bin\x86;C:\Progra;C:\Windows\System32;C:\Program Files (x86)\Microsoft Visual Studio 14.0\Common7\IDE;E:\Program Files\PuTTY\;C:\ecl\HOME;C:\ecl\MACROS;E:\Program Files\CMake\bin;e:\ecl\HOME;e:\ecl\MACROS;C:\Program Files\dotnet\;C:\Program Files\Microsoft SQL Server\130\Tools\Binn\;E:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.14.26428\bin\Hostx64\x64\;E:\Program Files (x86)\IncrediBuild;E:\Python36\Scripts\;E:\Python36\;C:\Users\AliReza\.dnx\bin;C:\Program Files (x86)\Intel\Trace Analyzer and Collector\9.0.2.045\dll;C:\Program Files (x86)\SSH Communications Security\SSH Secure Shell ProgramW6432=C:\Program Files USERNAME=AliReza FrameworkDIR64=C:\Windows\Microsoft.NET\Framework64 PROMPT=$P$G ADVISOR_2018_DIR=E:\Program Files (x86)\IntelSWTools\Advisor 2018\ INTEL_DEV_REDIST=C:\Program Files (x86)\Common Files\Intel\Shared Libraries\ FrameworkDir=C:\Windows\Microsoft.NET\Framework64\ PATHEXT=.COM;.EXE;.BAT;.CMD;.VBS;.VBE;.JS;.JSE;.WSF;.WSH;.MSC;.PY;.PYW CommonProgramW6432=C:\Program Files\Common Files WINDIR=C:\Windows windows_tracing_flags=3 NUMBER_OF_PROCESSORS=4 VSCMD_START_DIR=E:\cygwin64\home\alireza VCIDEInstallDir=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\Common7\IDE\VC\ WIN_TITLE=Intel Compiler 18.0 Update 3 Intel(R) 64 TARGET_VS_ARCH=amd64 MSMPI_INC=C:\Program Files (x86)\Microsoft SDKs\MPI\Include\ BIN_ROOT=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\bin\ USERPROFILE=C:\Users\AliReza VS140COMNTOOLS=C:\Program Files (x86)\Microsoft Visual Studio 14.0\Common7\Tools\ !E:=E:\cygwin64\home\alireza LIBPATH=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.15.26726\ATLMFC\lib\x64;e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.15.26726\lib\x64;e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.15.26726\lib\x86\store\references;C:\Program Files (x86)\Windows Kits\10\UnionMetadata\10.0.17134.0;C:\Program Files (x86)\Windows Kits\10\References\10.0.17134.0;C:\Windows\Microsoft.NET\Framework64\v4.0.30319; PROCESSOR_IDENTIFIER=Intel64 Family 6 Model 69 Stepping 1, GenuineIntel PROGRAMFILES=C:\Program Files PROCESSOR_REVISION=4501 PATH=/usr/bin:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/bin/intel64:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/compiler:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.15.26726/bin/HostX64/x64:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/VC/VCPackages:/cygdrive/c/Program Files (x86)/Microsoft SDKs/TypeScript/3.0:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TestWindow:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TeamFoundation/Team Explorer:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/Roslyn:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/x64:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/x64:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools:/cygdrive/c/Program Files (x86)/Microsoft SDKs/Windows/v10.0A/bin/NETFX 4.6.1 Tools/x64:/cygdrive/c/Program Files (x86)/HTML Help Workshop:/cygdrive/c/Program Files (x86)/Windows Kits/10/bin/10.0.17134.0/x64:/cygdrive/c/Program Files (x86)/Windows Kits/10/bin/x64:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin:/cygdrive/c/Windows/Microsoft.NET/Framework64/v4.0.30319:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/Tools:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin:/cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/gdb/intel64/bin:/cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/libipt/intel64/lib:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/ipp:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/daal:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/tbb/vc_mt:/cygdrive/c/Program Files (x86)/Common Files/Oracle/Java/javapath:/cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries_2018.3.210/windows/mpi/intel64/bin:/cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/mpirt:/cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/mpirt:/cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/compiler:/cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/compiler:/cygdrive/e/Python37/Scripts:/cygdrive/e/Python37:/cygdrive/e/Program Files (x86)/IntelSWTools/mpi/2018.1.156/intel64/bin:/cygdrive/c/Program Files/Microsoft MPI/Bin:/cygdrive/c/Program Files (x86)/Intel/MPI-RT/4.1.3.045/em64t/bin:/cygdrive/c/Program Files (x86)/CMG/CMGJobService:/cygdrive/c/Program Files (x86)/Intel/MPI/5.0.3.050/intel64/bin:/cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/mpirt:/cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/mpirt:/cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/compiler:/cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/compiler:/cygdrive/c/ProgramData/Oracle/Java/javapath:/cygdrive/c/Python27:/cygdrive/c/Python27/Scripts:/cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/bin:/cygdrive/c/Program Files (x86)/Intel/MPI/5.0.2.044/intel64/bin:/cygdrive/c/Program Files (x86)/Intel/Composer XE 2015/bin/ia32:/cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86_64:/cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86:/cygdrive/c/Progra:/cygdrive/c/Windows/System32:/cygdrive/c/Program Files (x86)/Microsoft Visual Studio 14.0/Common7/IDE:/cygdrive/e/Program Files/PuTTY:/cygdrive/c/ecl/HOME:/cygdrive/c/ecl/MACROS:/cygdrive/e/Program Files/CMake/bin:/cygdrive/e/ecl/HOME:/cygdrive/e/ecl/MACROS:/cygdrive/c/Program Files/dotnet:/cygdrive/c/Program Files/Microsoft SQL Server/130/Tools/Binn:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.14.26428/bin/Hostx64/x64:/cygdrive/e/Program Files (x86)/IncrediBuild:/cygdrive/e/Python36/Scripts:/cygdrive/e/Python36:/cygdrive/c/Users/AliReza/.dnx/bin:/cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/dll:/cygdrive/c/Program Files (x86)/SSH Communications Security/SSH Secure Shell:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/CMake/bin:/cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/Ninja MSMPI_BIN=C:\Program Files\Microsoft MPI\Bin\ PSTL_TARGET_ARCH=intel64 TERM=xterm WindowsSDKLibVersion=10.0.17134.0\ PSTL_BIN_DIR=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\pstl\bin\ PSTLROOT=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\pstl\bin\.. VSINSTALLDIR=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\ CMAKE_INCLUDE_PATH=C:\Users\AliReza\Desktop\boost_1_66_0\boost !::=::\ IPP_TARGET_ARCH=intel64 LOCALAPPDATA=C:\Users\AliReza\AppData\Local WindowsSDK_ExecutablePath_x64=C:\Program Files (x86)\Microsoft SDKs\Windows\v10.0A\bin\NETFX 4.6.1 Tools\x64\ ExtensionSdkDir=C:\Program Files (x86)\Microsoft SDKs\Windows Kits\10\ExtensionSDKs UniversalCRTSdkDir=C:\Program Files (x86)\Windows Kits\10\ __DOTNET_PREFERRED_BITNESS=64 ESET_OPTIONS= CMAKE_LIBRARY_PATH=C:\Users\AliReza\Desktop\boost_1_66_0\stage\lib UCRTVersion=10.0.17134.0 IPG_Dir=C:\Program Files\Intel\Power Gadget 3.0 IFCPATH=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\Tools\MSVC\14.15.26726\ifc\x64 FP_NO_HOST_CHECK=NO DAALROOT=E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\daal VSCMD_ARG_HOST_ARCH=x64 TBB_TARGET_VS=vc_mt OLDPWD=/home/alireza NETFXSDKDir=C:\Program Files (x86)\Windows Kits\NETFXSDK\4.6.1\ WindowsSdkVerBinPath=C:\Program Files (x86)\Windows Kits\10\bin\10.0.17134.0\ PWD=/home/alireza/petsc-3.9.3 IPG_Ver=3.0 MSMPI_LIB32=C:\Program Files (x86)\Microsoft SDKs\MPI\Lib\x86\ VCINSTALLDIR=e:\Program Files (x86)\Microsoft Visual Studio\2017\Enterprise\VC\ ================================================================================ TEST resetEnvCompilers from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1640) TESTING: resetEnvCompilers from config.setCompilers(config/BuildSystem/config/setCompilers.py:1640) ================================================================================ TEST checkEnvCompilers from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1670) TESTING: checkEnvCompilers from config.setCompilers(config/BuildSystem/config/setCompilers.py:1670) ================================================================================ TEST checkMPICompilerOverride from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1605) TESTING: checkMPICompilerOverride from config.setCompilers(config/BuildSystem/config/setCompilers.py:1605) Check if --with-mpi-dir is used along with CC CXX or FC compiler options. This usually prevents mpi compilers from being used - so issue a warning ================================================================================ TEST requireMpiLdPath from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1624) TESTING: requireMpiLdPath from config.setCompilers(config/BuildSystem/config/setCompilers.py:1624) OpenMPI wrappers require LD_LIBRARY_PATH set ================================================================================ TEST checkVendor from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:444) TESTING: checkVendor from config.setCompilers(config/BuildSystem/config/setCompilers.py:444) Determine the compiler vendor Compiler vendor is "" ================================================================================ TEST checkInitialFlags from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:454) TESTING: checkInitialFlags from config.setCompilers(config/BuildSystem/config/setCompilers.py:454) Initialize the compiler and linker flags Pushing language C Initialized CFLAGS to -O2 -MT -wd4996 -Qopenmp Initialized CFLAGS to -O2 -MT -wd4996 -Qopenmp Initialized LDFLAGS to Popping language C Pushing language CUDA Initialized CUDAFLAGS to Initialized CUDAFLAGS to Initialized LDFLAGS to Popping language CUDA Pushing language Cxx Initialized CXXFLAGS to -O2 -MT -wd4996 -Qopenmp Initialized CXX_CXXFLAGS to Initialized LDFLAGS to Popping language Cxx Pushing language FC Initialized FFLAGS to -MT -O2 -Qopenmp Initialized FFLAGS to -MT -O2 -Qopenmp Initialized LDFLAGS to Popping language FC Initialized CPPFLAGS to Initialized CUDAPPFLAGS to -Wno-deprecated-gpu-targets Initialized CXXCPPFLAGS to Initialized CC_LINKER_FLAGS to [] Initialized CXX_LINKER_FLAGS to [] Initialized FC_LINKER_FLAGS to [] Initialized CUDAC_LINKER_FLAGS to [] Initialized sharedLibraryFlags to [] Initialized dynamicLibraryFlags to [] ================================================================================ TEST checkCCompiler from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:586) TESTING: checkCCompiler from config.setCompilers(config/BuildSystem/config/setCompilers.py:586) Locate a functional C compiler Checking for program /usr/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/bin/intel64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.15.26726/bin/HostX64/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/VC/VCPackages/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/TypeScript/3.0/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TestWindow/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TeamFoundation/Team Explorer/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/Roslyn/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/Windows/v10.0A/bin/NETFX 4.6.1 Tools/x64/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/HTML Help Workshop/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/10.0.17134.0/x64/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/win32fe...not found Checking for program /cygdrive/c/Windows/Microsoft.NET/Framework64/v4.0.30319/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/Tools/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/gdb/intel64/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/libipt/intel64/lib/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/ipp/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/daal/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/tbb/vc_mt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Oracle/Java/javapath/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries_2018.3.210/windows/mpi/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/compiler/win32fe...not found Checking for program /cygdrive/e/Python37/Scripts/win32fe...not found Checking for program /cygdrive/e/Python37/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/mpi/2018.1.156/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files/Microsoft MPI/Bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI-RT/4.1.3.045/em64t/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/CMG/CMGJobService/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.3.050/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/compiler/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/compiler/win32fe...not found Checking for program /cygdrive/c/ProgramData/Oracle/Java/javapath/win32fe...not found Checking for program /cygdrive/c/Python27/win32fe...not found Checking for program /cygdrive/c/Python27/Scripts/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.2.044/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Composer XE 2015/bin/ia32/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86_64/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86/win32fe...not found Checking for program /cygdrive/c/Progra/win32fe...not found Checking for program /cygdrive/c/Windows/System32/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft Visual Studio 14.0/Common7/IDE/win32fe...not found Checking for program /cygdrive/e/Program Files/PuTTY/win32fe...not found Checking for program /cygdrive/c/ecl/HOME/win32fe...not found Checking for program /cygdrive/c/ecl/MACROS/win32fe...not found Checking for program /cygdrive/e/Program Files/CMake/bin/win32fe...not found Checking for program /cygdrive/e/ecl/HOME/win32fe...not found Checking for program /cygdrive/e/ecl/MACROS/win32fe...not found Checking for program /cygdrive/c/Program Files/dotnet/win32fe...not found Checking for program /cygdrive/c/Program Files/Microsoft SQL Server/130/Tools/Binn/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.14.26428/bin/Hostx64/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IncrediBuild/win32fe...not found Checking for program /cygdrive/e/Python36/Scripts/win32fe...not found Checking for program /cygdrive/e/Python36/win32fe...not found Checking for program /cygdrive/c/Users/AliReza/.dnx/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/dll/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/SSH Communications Security/SSH Secure Shell/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/CMake/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/Ninja/win32fe...not found Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe...found Defined make macro "CC" to "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" Pushing language C All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Pushing language CUDA Popping language CUDA Pushing language Cxx Popping language Cxx Pushing language FC Popping language FC Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -lpetsc-ufod4vtr9mqHvKIQiVAm stdout: ipo: error #11018: Cannot open libpetsc-ufod4vtr9mqHvKIQiVAm.lib LINK : fatal error LNK1181: cannot open input file 'libpetsc-ufod4vtr9mqHvKIQiVAm.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libpetsc-ufod4vtr9mqHvKIQiVAm.lib LINK : fatal error LNK1181: cannot open input file 'libpetsc-ufod4vtr9mqHvKIQiVAm.lib'Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe Popping language C ================================================================================ TEST checkCPreprocessor from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:619) TESTING: checkCPreprocessor from config.setCompilers(config/BuildSystem/config/setCompilers.py:619) Locate a functional C preprocessor Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe...found Defined make macro "CPP" to "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E" Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" #pragma once __pragma(pack(push, 8)) #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __declspec(allocator) __declspec(restrict) void* __cdecl _calloc_base( size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl calloc( size_t _Count, size_t _Size ); int __cdecl _callnewh( size_t _Size ); __declspec(allocator) void* __cdecl _expand( void* _Block, size_t _Size ); void __cdecl _free_base( void* _Block ); void __cdecl free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _malloc_base( size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl malloc( size_t _Size ); size_t __cdecl _msize_base( void* _Block ); size_t __cdecl _msize( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _realloc_base( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl realloc( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc_base( void* _Block, size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc( void* _Block, size_t _Count, size_t _Size ); void __cdecl _aligned_free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_malloc( size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_malloc( size_t _Size, size_t _Alignment, size_t _Offset ); size_t __cdecl _aligned_msize( void* _Block, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_realloc( void* _Block, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_realloc( void* _Block, size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment ); #line 225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __pragma(pack(push, 8)) typedef int (__cdecl* _CoreCrtSecureSearchSortCompareFunction)(void*, void const*, void const*); typedef int (__cdecl* _CoreCrtNonSecureSearchSortCompareFunction)(void const*, void const*); void* __cdecl bsearch_s( void const* _Key, void const* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void __cdecl qsort_s( void* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl bsearch( void const* _Key, void const* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void __cdecl qsort( void* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lfind_s( void const* _Key, void const* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lsearch_s( void const* _Key, void* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); #line 185 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lfind" ". See online help for details.")) void* __cdecl lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lsearch" ". See online help for details.")) void* __cdecl lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma once __pragma(pack(push, 8)) errno_t __cdecl _itow_s( int _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _itow(int _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ltow_s( long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ltow(long _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ultow_s( unsigned long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ultow(unsigned long _Value, wchar_t *_Buffer, int _Radix); double __cdecl wcstod( wchar_t const* _String, wchar_t** _EndPtr ); double __cdecl _wcstod_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); long __cdecl wcstol( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long __cdecl _wcstol_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl wcstoll( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long long __cdecl _wcstoll_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl wcstoul( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long __cdecl _wcstoul_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl wcstoull( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long long __cdecl _wcstoull_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long double __cdecl wcstold( wchar_t const* _String, wchar_t** _EndPtr ); long double __cdecl _wcstold_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); float __cdecl wcstof( wchar_t const* _String, wchar_t** _EndPtr ); float __cdecl _wcstof_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); double __cdecl _wtof( wchar_t const* _String ); double __cdecl _wtof_l( wchar_t const* _String, _locale_t _Locale ); int __cdecl _wtoi( wchar_t const* _String ); int __cdecl _wtoi_l( wchar_t const* _String, _locale_t _Locale ); long __cdecl _wtol( wchar_t const* _String ); long __cdecl _wtol_l( wchar_t const* _String, _locale_t _Locale ); long long __cdecl _wtoll( wchar_t const* _String ); long long __cdecl _wtoll_l( wchar_t const* _String, _locale_t _Locale ); errno_t __cdecl _i64tow_s( __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _i64tow( __int64 _Value, wchar_t* _Buffer, int _Radix ); errno_t __cdecl _ui64tow_s( unsigned __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ui64tow( unsigned __int64 _Value, wchar_t* _Buffer, int _Radix ); __int64 __cdecl _wtoi64( wchar_t const* _String ); __int64 __cdecl _wtoi64_l( wchar_t const* _String, _locale_t _Locale ); __int64 __cdecl _wcstoi64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); __int64 __cdecl _wcstoi64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _wcstoui64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned __int64 __cdecl _wcstoui64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); __declspec(allocator) wchar_t* __cdecl _wfullpath( wchar_t* _Buffer, wchar_t const* _Path, size_t _BufferCount ); errno_t __cdecl _wmakepath_s( wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext ); #line 361 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wmakepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wmakepath( wchar_t *_Buffer, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext); #pragma warning(pop) void __cdecl _wperror( wchar_t const* _ErrorMessage ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsplitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsplitpath( wchar_t const* _FullPath, wchar_t* _Drive, wchar_t* _Dir, wchar_t* _Filename, wchar_t* _Ext ); errno_t __cdecl _wsplitpath_s( wchar_t const* _FullPath, wchar_t* _Drive, size_t _DriveCount, wchar_t* _Dir, size_t _DirCount, wchar_t* _Filename, size_t _FilenameCount, wchar_t* _Ext, size_t _ExtCount ); errno_t __cdecl _wdupenv_s( wchar_t** _Buffer, size_t* _BufferCount, wchar_t const* _VarName ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wdupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wgetenv( wchar_t const* _VarName ); errno_t __cdecl _wgetenv_s( size_t* _RequiredCount, wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _VarName ); #line 438 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" int __cdecl _wputenv( wchar_t const* _EnvString ); errno_t __cdecl _wputenv_s( wchar_t const* _Name, wchar_t const* _Value ); errno_t __cdecl _wsearchenv_s( wchar_t const* _Filename, wchar_t const* _VarName, wchar_t* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsearchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsearchenv(wchar_t const* _Filename, wchar_t const* _VarName, wchar_t *_ResultPath); int __cdecl _wsystem( wchar_t const* _Command ); __pragma(pack(pop)) #line 16 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #pragma once __pragma(pack(push, 8)) #line 29 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 43 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 71 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 79 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" __pragma(pack(pop)) #line 17 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __pragma(pack(push, 8)) void __cdecl _swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(noreturn) void __cdecl exit( int _Code); __declspec(noreturn) void __cdecl _exit( int _Code); __declspec(noreturn) void __cdecl _Exit( int _Code); __declspec(noreturn) void __cdecl quick_exit( int _Code); __declspec(noreturn) void __cdecl abort(void); unsigned int __cdecl _set_abort_behavior( unsigned int _Flags, unsigned int _Mask ); typedef int (__cdecl* _onexit_t)(void); #line 117 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 140 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl atexit(void (__cdecl*)(void)); _onexit_t __cdecl _onexit( _onexit_t _Func); int __cdecl at_quick_exit(void (__cdecl*)(void)); typedef void (__cdecl* _purecall_handler)(void); typedef void (__cdecl* _invalid_parameter_handler)( wchar_t const*, wchar_t const*, wchar_t const*, unsigned int, uintptr_t ); _purecall_handler __cdecl _set_purecall_handler( _purecall_handler _Handler ); _purecall_handler __cdecl _get_purecall_handler(void); _invalid_parameter_handler __cdecl _set_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_invalid_parameter_handler(void); _invalid_parameter_handler __cdecl _set_thread_local_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_thread_local_invalid_parameter_handler(void); #line 199 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl _set_error_mode( int _Mode); int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); unsigned long* __cdecl __doserrno(void); errno_t __cdecl _set_doserrno( unsigned long _Value); errno_t __cdecl _get_doserrno( unsigned long * _Value); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __sys_errlist(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int * __cdecl __sys_nerr(void); void __cdecl perror( char const* _ErrMsg); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_pgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __p__pgmptr (void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_wpgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t** __cdecl __p__wpgmptr(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_fmode" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int* __cdecl __p__fmode (void); #line 253 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" errno_t __cdecl _get_pgmptr ( char** _Value); errno_t __cdecl _get_wpgmptr( wchar_t** _Value); errno_t __cdecl _set_fmode ( int _Mode ); errno_t __cdecl _get_fmode ( int* _PMode); typedef struct _div_t { int quot; int rem; } div_t; typedef struct _ldiv_t { long quot; long rem; } ldiv_t; typedef struct _lldiv_t { long long quot; long long rem; } lldiv_t; int __cdecl abs ( int _Number); long __cdecl labs ( long _Number); long long __cdecl llabs ( long long _Number); __int64 __cdecl _abs64( __int64 _Number); unsigned short __cdecl _byteswap_ushort( unsigned short _Number); unsigned long __cdecl _byteswap_ulong ( unsigned long _Number); unsigned __int64 __cdecl _byteswap_uint64( unsigned __int64 _Number); div_t __cdecl div ( int _Numerator, int _Denominator); ldiv_t __cdecl ldiv ( long _Numerator, long _Denominator); lldiv_t __cdecl lldiv( long long _Numerator, long long _Denominator); #pragma warning (push) #pragma warning (disable:6540) unsigned int __cdecl _rotl( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotl( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotl64( unsigned __int64 _Value, int _Shift ); unsigned int __cdecl _rotr( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotr( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotr64( unsigned __int64 _Value, int _Shift ); #pragma warning (pop) void __cdecl srand( unsigned int _Seed); int __cdecl rand(void); #line 380 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma pack(push, 4) typedef struct { unsigned char ld[10]; } _LDOUBLE; #pragma pack(pop) #line 410 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" typedef struct { double x; } _CRT_DOUBLE; typedef struct { float f; } _CRT_FLOAT; typedef struct { long double x; } _LONGDOUBLE; #pragma pack(push, 4) typedef struct { unsigned char ld12[12]; } _LDBL12; #pragma pack(pop) double __cdecl atof ( char const* _String); int __cdecl atoi ( char const* _String); long __cdecl atol ( char const* _String); long long __cdecl atoll ( char const* _String); __int64 __cdecl _atoi64( char const* _String); double __cdecl _atof_l ( char const* _String, _locale_t _Locale); int __cdecl _atoi_l ( char const* _String, _locale_t _Locale); long __cdecl _atol_l ( char const* _String, _locale_t _Locale); long long __cdecl _atoll_l ( char const* _String, _locale_t _Locale); __int64 __cdecl _atoi64_l( char const* _String, _locale_t _Locale); int __cdecl _atoflt ( _CRT_FLOAT* _Result, char const* _String); int __cdecl _atodbl ( _CRT_DOUBLE* _Result, char* _String); int __cdecl _atoldbl( _LDOUBLE* _Result, char* _String); int __cdecl _atoflt_l( _CRT_FLOAT* _Result, char const* _String, _locale_t _Locale ); int __cdecl _atodbl_l( _CRT_DOUBLE* _Result, char* _String, _locale_t _Locale ); int __cdecl _atoldbl_l( _LDOUBLE* _Result, char* _String, _locale_t _Locale ); float __cdecl strtof( char const* _String, char** _EndPtr ); float __cdecl _strtof_l( char const* _String, char** _EndPtr, _locale_t _Locale ); double __cdecl strtod( char const* _String, char** _EndPtr ); double __cdecl _strtod_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long double __cdecl strtold( char const* _String, char** _EndPtr ); long double __cdecl _strtold_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long __cdecl strtol( char const* _String, char** _EndPtr, int _Radix ); long __cdecl _strtol_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl strtoll( char const* _String, char** _EndPtr, int _Radix ); long long __cdecl _strtoll_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl strtoul( char const* _String, char** _EndPtr, int _Radix ); unsigned long __cdecl _strtoul_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl strtoull( char const* _String, char** _EndPtr, int _Radix ); unsigned long long __cdecl _strtoull_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); __int64 __cdecl _strtoi64( char const* _String, char** _EndPtr, int _Radix ); __int64 __cdecl _strtoi64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _strtoui64( char const* _String, char** _EndPtr, int _Radix ); unsigned __int64 __cdecl _strtoui64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); errno_t __cdecl _itoa_s( int _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _itoa(int _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _ltoa_s( long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ltoa(long _Value, char *_Buffer, int _Radix); errno_t __cdecl _ultoa_s( unsigned long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ultoa(unsigned long _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _i64toa_s( __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _i64toa( __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ui64toa_s( unsigned __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ui64toa( unsigned __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ecvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _fcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _gcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _gcvt( double _Value, int _DigitCount, char* _Buffer ); #line 838 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl ___mb_cur_max_func(void); int __cdecl ___mb_cur_max_l_func(_locale_t _Locale); int __cdecl mblen( char const* _Ch, size_t _MaxCount ); int __cdecl _mblen_l( char const* _Ch, size_t _MaxCount, _locale_t _Locale ); size_t __cdecl _mbstrlen( char const* _String ); size_t __cdecl _mbstrlen_l( char const* _String, _locale_t _Locale ); size_t __cdecl _mbstrnlen( char const* _String, size_t _MaxCount ); size_t __cdecl _mbstrnlen_l( char const* _String, size_t _MaxCount, _locale_t _Locale ); int __cdecl mbtowc( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes ); int __cdecl _mbtowc_l( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes, _locale_t _Locale ); errno_t __cdecl mbstowcs_s( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "mbstowcs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl mbstowcs( wchar_t *_Dest, char const* _Source, size_t _MaxCount); errno_t __cdecl _mbstowcs_s_l( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_mbstowcs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _mbstowcs_l( wchar_t *_Dest, char const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wctomb_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl wctomb( char* _MbCh, wchar_t _WCh ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctomb_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _wctomb_l( char* _MbCh, wchar_t _WCh, _locale_t _Locale ); errno_t __cdecl wctomb_s( int* _SizeConverted, char* _MbCh, rsize_t _SizeInBytes, wchar_t _WCh ); errno_t __cdecl _wctomb_s_l( int* _SizeConverted, char* _MbCh, size_t _SizeInBytes, wchar_t _WCh, _locale_t _Locale); errno_t __cdecl wcstombs_s( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstombs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl wcstombs( char *_Dest, wchar_t const* _Source, size_t _MaxCount); errno_t __cdecl _wcstombs_s_l( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcstombs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _wcstombs_l( char *_Dest, wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(allocator) char* __cdecl _fullpath( char* _Buffer, char const* _Path, size_t _BufferCount ); errno_t __cdecl _makepath_s( char* _Buffer, size_t _BufferCount, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_makepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _makepath( char *_Buffer, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext); #pragma warning(pop) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_splitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _splitpath( char const* _FullPath, char* _Drive, char* _Dir, char* _Filename, char* _Ext ); errno_t __cdecl _splitpath_s( char const* _FullPath, char* _Drive, size_t _DriveCount, char* _Dir, size_t _DirCount, char* _Filename, size_t _FilenameCount, char* _Ext, size_t _ExtCount ); errno_t __cdecl getenv_s( size_t* _RequiredCount, char* _Buffer, rsize_t _BufferCount, char const* _VarName ); int* __cdecl __p___argc (void); char*** __cdecl __p___argv (void); wchar_t*** __cdecl __p___wargv(void); #line 1164 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" char*** __cdecl __p__environ (void); wchar_t*** __cdecl __p__wenviron(void); #line 1181 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "_dupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl getenv( char const* _VarName ); errno_t __cdecl _dupenv_s( char** _Buffer, size_t* _BufferCount, char const* _VarName ); int __cdecl system( char const* _Command ); #pragma warning (push) #pragma warning (disable:6540) int __cdecl _putenv( char const* _EnvString ); errno_t __cdecl _putenv_s( char const* _Name, char const* _Value ); #pragma warning (pop) errno_t __cdecl _searchenv_s( char const* _Filename, char const* _VarName, char* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_searchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _searchenv(char const* _Filename, char const* _VarName, char *_Buffer); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "SetErrorMode" " " "instead. See online help for details.")) void __cdecl _seterrormode( int _Mode ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Beep" " " "instead. See online help for details.")) void __cdecl _beep( unsigned _Frequency, unsigned _Duration ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Sleep" " " "instead. See online help for details.")) void __cdecl _sleep( unsigned long _Duration ); #pragma warning(push) #pragma warning(disable: 4141) __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ecvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_fcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_gcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl gcvt( double _Value, int _DigitCount, char* _DstBuf ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_itoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl itoa( int _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ltoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ltoa( long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_swab" ". See online help for details.")) void __cdecl swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ultoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ultoa( unsigned long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_putenv" ". See online help for details.")) int __cdecl putenv( char const* _EnvString ); #pragma warning(pop) _onexit_t __cdecl onexit( _onexit_t _Func); __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Popping language C ================================================================================ TEST checkCUDACompiler from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:660) TESTING: checkCUDACompiler from config.setCompilers(config/BuildSystem/config/setCompilers.py:660) Locate a functional CUDA compiler ================================================================================ TEST checkCUDAPreprocessor from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:700) TESTING: checkCUDAPreprocessor from config.setCompilers(config/BuildSystem/config/setCompilers.py:700) Locate a functional CUDA preprocessor ================================================================================ TEST checkCxxCompiler from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:812) TESTING: checkCxxCompiler from config.setCompilers(config/BuildSystem/config/setCompilers.py:812) Locate a functional Cxx compiler Checking for program /usr/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/bin/intel64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.15.26726/bin/HostX64/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/VC/VCPackages/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/TypeScript/3.0/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TestWindow/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TeamFoundation/Team Explorer/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/Roslyn/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/Windows/v10.0A/bin/NETFX 4.6.1 Tools/x64/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/HTML Help Workshop/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/10.0.17134.0/x64/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/win32fe...not found Checking for program /cygdrive/c/Windows/Microsoft.NET/Framework64/v4.0.30319/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/Tools/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/gdb/intel64/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/libipt/intel64/lib/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/ipp/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/daal/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/tbb/vc_mt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Oracle/Java/javapath/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries_2018.3.210/windows/mpi/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/compiler/win32fe...not found Checking for program /cygdrive/e/Python37/Scripts/win32fe...not found Checking for program /cygdrive/e/Python37/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/mpi/2018.1.156/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files/Microsoft MPI/Bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI-RT/4.1.3.045/em64t/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/CMG/CMGJobService/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.3.050/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/compiler/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/compiler/win32fe...not found Checking for program /cygdrive/c/ProgramData/Oracle/Java/javapath/win32fe...not found Checking for program /cygdrive/c/Python27/win32fe...not found Checking for program /cygdrive/c/Python27/Scripts/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.2.044/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Composer XE 2015/bin/ia32/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86_64/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86/win32fe...not found Checking for program /cygdrive/c/Progra/win32fe...not found Checking for program /cygdrive/c/Windows/System32/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft Visual Studio 14.0/Common7/IDE/win32fe...not found Checking for program /cygdrive/e/Program Files/PuTTY/win32fe...not found Checking for program /cygdrive/c/ecl/HOME/win32fe...not found Checking for program /cygdrive/c/ecl/MACROS/win32fe...not found Checking for program /cygdrive/e/Program Files/CMake/bin/win32fe...not found Checking for program /cygdrive/e/ecl/HOME/win32fe...not found Checking for program /cygdrive/e/ecl/MACROS/win32fe...not found Checking for program /cygdrive/c/Program Files/dotnet/win32fe...not found Checking for program /cygdrive/c/Program Files/Microsoft SQL Server/130/Tools/Binn/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.14.26428/bin/Hostx64/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IncrediBuild/win32fe...not found Checking for program /cygdrive/e/Python36/Scripts/win32fe...not found Checking for program /cygdrive/e/Python36/win32fe...not found Checking for program /cygdrive/c/Users/AliReza/.dnx/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/dll/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/SSH Communications Security/SSH Secure Shell/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/CMake/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/Ninja/win32fe...not found Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe...found Defined make macro "CXX" to "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Pushing language CUDA Popping language CUDA Pushing language Cxx Popping language Cxx Pushing language FC Popping language FC Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -lpetsc-ufod4vtr9mqHvKIQiVAm stdout: ipo: error #11018: Cannot open libpetsc-ufod4vtr9mqHvKIQiVAm.lib LINK : fatal error LNK1181: cannot open input file 'libpetsc-ufod4vtr9mqHvKIQiVAm.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libpetsc-ufod4vtr9mqHvKIQiVAm.lib LINK : fatal error LNK1181: cannot open input file 'libpetsc-ufod4vtr9mqHvKIQiVAm.lib'Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe Popping language Cxx ================================================================================ TEST checkCxxPreprocessor from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:850) TESTING: checkCxxPreprocessor from config.setCompilers(config/BuildSystem/config/setCompilers.py:850) Locate a functional Cxx preprocessor Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe...found Defined make macro "CXXCPP" to "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E" Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\conftest.cc" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\conftest.cc" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\conffix.h" extern "C" { } #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\conftest.cc" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\cstdlib" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #pragma once #line 219 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\xkeycheck.h" #pragma once #line 91 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\xkeycheck.h" #line 263 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\xkeycheck.h" #line 221 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\crtdefs.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" extern "C" { #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" } #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once extern "C" { #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" } #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) extern "C" { typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" } extern "C++" { template struct __vcrt_va_list_is_reference { enum : bool { __the_value = false }; }; template struct __vcrt_va_list_is_reference<_Ty&> { enum : bool { __the_value = true }; }; template struct __vcrt_va_list_is_reference<_Ty&&> { enum : bool { __the_value = true }; }; template struct __vcrt_assert_va_start_is_not_reference { static_assert(!__vcrt_va_list_is_reference<_Ty>::__the_value, "va_start argument must not have reference type and must not be parenthesized"); }; } #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 82 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) extern "C" { #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; typedef bool __vcrt_bool; #line 198 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" extern "C++" { template char (*__countof_helper(__unaligned _CountofType (&_Array)[_SizeOfArray]))[_SizeOfArray]; } #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; } __pragma(pack(pop)) #line 10 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\crtdefs.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once __pragma(pack(push, 8)) extern "C" { #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" extern "C++" { template struct _CrtEnableIf; template struct _CrtEnableIf { typedef _Ty _Type; }; } typedef bool __crt_bool; #line 147 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 557 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 568 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 579 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 590 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 601 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 612 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 623 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 634 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 645 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 661 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 677 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 694 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 712 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" } __pragma(pack(pop)) #line 11 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\crtdefs.h" #line 26 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\crtdefs.h" #line 35 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\crtdefs.h" #line 44 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\crtdefs.h" #line 56 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\crtdefs.h" #line 222 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 230 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 276 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 284 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 304 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 312 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 397 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 413 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 437 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 458 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 473 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 483 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 495 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 507 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 519 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 530 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 542 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 554 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 565 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 588 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 614 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 630 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 644 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 660 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 668 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 676 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 700 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 719 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 753 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 777 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 785 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 813 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\yvals_core.h" #line 8 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\cstdlib" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" #pragma once __pragma(pack(push, 8)) extern "C" { #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __declspec(allocator) __declspec(restrict) void* __cdecl _calloc_base( size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl calloc( size_t _Count, size_t _Size ); int __cdecl _callnewh( size_t _Size ); __declspec(allocator) void* __cdecl _expand( void* _Block, size_t _Size ); void __cdecl _free_base( void* _Block ); void __cdecl free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _malloc_base( size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl malloc( size_t _Size ); size_t __cdecl _msize_base( void* _Block ); size_t __cdecl _msize( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _realloc_base( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl realloc( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc_base( void* _Block, size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc( void* _Block, size_t _Count, size_t _Size ); void __cdecl _aligned_free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_malloc( size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_malloc( size_t _Size, size_t _Alignment, size_t _Offset ); size_t __cdecl _aligned_msize( void* _Block, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_realloc( void* _Block, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_realloc( void* _Block, size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment ); #line 225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" } __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once __pragma(pack(push, 8)) extern "C" { namespace std { typedef decltype(__nullptr) nullptr_t; } using ::std::nullptr_t; int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); } __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __pragma(pack(push, 8)) extern "C" { typedef int (__cdecl* _CoreCrtSecureSearchSortCompareFunction)(void*, void const*, void const*); typedef int (__cdecl* _CoreCrtNonSecureSearchSortCompareFunction)(void const*, void const*); void* __cdecl bsearch_s( void const* _Key, void const* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void __cdecl qsort_s( void* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl bsearch( void const* _Key, void const* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void __cdecl qsort( void* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lfind_s( void const* _Key, void const* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lsearch_s( void const* _Key, void* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); #line 185 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lfind" ". See online help for details.")) void* __cdecl lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lsearch" ". See online help for details.")) void* __cdecl lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); } __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma once __pragma(pack(push, 8)) extern "C" { errno_t __cdecl _itow_s( int _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); extern "C++" { template inline errno_t __cdecl _itow_s(int _Value, wchar_t (&_Buffer)[_Size], int _Radix) throw() { return _itow_s(_Value, _Buffer, _Size, _Radix); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _itow(int _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ltow_s( long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); extern "C++" { template inline errno_t __cdecl _ltow_s(long _Value, wchar_t (&_Buffer)[_Size], int _Radix) throw() { return _ltow_s(_Value, _Buffer, _Size, _Radix); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ltow(long _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ultow_s( unsigned long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); extern "C++" { template inline errno_t __cdecl _ultow_s(unsigned long _Value, wchar_t (&_Buffer)[_Size], int _Radix) throw() { return _ultow_s(_Value, _Buffer, _Size, _Radix); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ultow(unsigned long _Value, wchar_t *_Buffer, int _Radix); double __cdecl wcstod( wchar_t const* _String, wchar_t** _EndPtr ); double __cdecl _wcstod_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); long __cdecl wcstol( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long __cdecl _wcstol_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl wcstoll( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long long __cdecl _wcstoll_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl wcstoul( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long __cdecl _wcstoul_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl wcstoull( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long long __cdecl _wcstoull_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long double __cdecl wcstold( wchar_t const* _String, wchar_t** _EndPtr ); long double __cdecl _wcstold_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); float __cdecl wcstof( wchar_t const* _String, wchar_t** _EndPtr ); float __cdecl _wcstof_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); double __cdecl _wtof( wchar_t const* _String ); double __cdecl _wtof_l( wchar_t const* _String, _locale_t _Locale ); int __cdecl _wtoi( wchar_t const* _String ); int __cdecl _wtoi_l( wchar_t const* _String, _locale_t _Locale ); long __cdecl _wtol( wchar_t const* _String ); long __cdecl _wtol_l( wchar_t const* _String, _locale_t _Locale ); long long __cdecl _wtoll( wchar_t const* _String ); long long __cdecl _wtoll_l( wchar_t const* _String, _locale_t _Locale ); errno_t __cdecl _i64tow_s( __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _i64tow( __int64 _Value, wchar_t* _Buffer, int _Radix ); errno_t __cdecl _ui64tow_s( unsigned __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ui64tow( unsigned __int64 _Value, wchar_t* _Buffer, int _Radix ); __int64 __cdecl _wtoi64( wchar_t const* _String ); __int64 __cdecl _wtoi64_l( wchar_t const* _String, _locale_t _Locale ); __int64 __cdecl _wcstoi64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); __int64 __cdecl _wcstoi64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _wcstoui64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned __int64 __cdecl _wcstoui64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); __declspec(allocator) wchar_t* __cdecl _wfullpath( wchar_t* _Buffer, wchar_t const* _Path, size_t _BufferCount ); errno_t __cdecl _wmakepath_s( wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext ); extern "C++" { template inline errno_t __cdecl _wmakepath_s(wchar_t (&_Buffer)[_Size], wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext) throw() { return _wmakepath_s(_Buffer, _Size, _Drive, _Dir, _Filename, _Ext); } } #line 361 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wmakepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wmakepath( wchar_t *_Buffer, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext); #pragma warning(pop) void __cdecl _wperror( wchar_t const* _ErrorMessage ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsplitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsplitpath( wchar_t const* _FullPath, wchar_t* _Drive, wchar_t* _Dir, wchar_t* _Filename, wchar_t* _Ext ); errno_t __cdecl _wsplitpath_s( wchar_t const* _FullPath, wchar_t* _Drive, size_t _DriveCount, wchar_t* _Dir, size_t _DirCount, wchar_t* _Filename, size_t _FilenameCount, wchar_t* _Ext, size_t _ExtCount ); extern "C++" { template inline errno_t __cdecl _wsplitpath_s( wchar_t const* _Path, wchar_t (&_Drive)[_DriveSize], wchar_t (&_Dir)[_DirSize], wchar_t (&_Name)[_NameSize], wchar_t (&_Ext)[_ExtSize] ) throw() { return _wsplitpath_s(_Path, _Drive, _DriveSize, _Dir, _DirSize, _Name, _NameSize, _Ext, _ExtSize); } } errno_t __cdecl _wdupenv_s( wchar_t** _Buffer, size_t* _BufferCount, wchar_t const* _VarName ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wdupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wgetenv( wchar_t const* _VarName ); errno_t __cdecl _wgetenv_s( size_t* _RequiredCount, wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _VarName ); extern "C++" { template inline errno_t __cdecl _wgetenv_s(size_t* _RequiredCount, wchar_t (&_Buffer)[_Size], wchar_t const* _VarName) throw() { return _wgetenv_s(_RequiredCount, _Buffer, _Size, _VarName); } } #line 438 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" int __cdecl _wputenv( wchar_t const* _EnvString ); errno_t __cdecl _wputenv_s( wchar_t const* _Name, wchar_t const* _Value ); errno_t __cdecl _wsearchenv_s( wchar_t const* _Filename, wchar_t const* _VarName, wchar_t* _Buffer, size_t _BufferCount ); extern "C++" { template inline errno_t __cdecl _wsearchenv_s(wchar_t const* _Filename, wchar_t const* _VarName, wchar_t (&_ResultPath)[_Size]) throw() { return _wsearchenv_s(_Filename, _VarName, _ResultPath, _Size); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsearchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsearchenv(wchar_t const* _Filename, wchar_t const* _VarName, wchar_t *_ResultPath); int __cdecl _wsystem( wchar_t const* _Command ); } __pragma(pack(pop)) #line 16 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #pragma once __pragma(pack(push, 8)) extern "C" { #line 29 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 43 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 71 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 79 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" } __pragma(pack(pop)) #line 17 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __pragma(pack(push, 8)) extern "C" { void __cdecl _swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(noreturn) void __cdecl exit( int _Code); __declspec(noreturn) void __cdecl _exit( int _Code); __declspec(noreturn) void __cdecl _Exit( int _Code); __declspec(noreturn) void __cdecl quick_exit( int _Code); __declspec(noreturn) void __cdecl abort(void); unsigned int __cdecl _set_abort_behavior( unsigned int _Flags, unsigned int _Mask ); typedef int (__cdecl* _onexit_t)(void); #line 117 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 140 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl atexit(void (__cdecl*)(void)); _onexit_t __cdecl _onexit( _onexit_t _Func); int __cdecl at_quick_exit(void (__cdecl*)(void)); typedef void (__cdecl* _purecall_handler)(void); typedef void (__cdecl* _invalid_parameter_handler)( wchar_t const*, wchar_t const*, wchar_t const*, unsigned int, uintptr_t ); _purecall_handler __cdecl _set_purecall_handler( _purecall_handler _Handler ); _purecall_handler __cdecl _get_purecall_handler(void); _invalid_parameter_handler __cdecl _set_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_invalid_parameter_handler(void); _invalid_parameter_handler __cdecl _set_thread_local_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_thread_local_invalid_parameter_handler(void); #line 199 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl _set_error_mode( int _Mode); int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); unsigned long* __cdecl __doserrno(void); errno_t __cdecl _set_doserrno( unsigned long _Value); errno_t __cdecl _get_doserrno( unsigned long * _Value); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __sys_errlist(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int * __cdecl __sys_nerr(void); void __cdecl perror( char const* _ErrMsg); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_pgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __p__pgmptr (void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_wpgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t** __cdecl __p__wpgmptr(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_fmode" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int* __cdecl __p__fmode (void); #line 253 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" errno_t __cdecl _get_pgmptr ( char** _Value); errno_t __cdecl _get_wpgmptr( wchar_t** _Value); errno_t __cdecl _set_fmode ( int _Mode ); errno_t __cdecl _get_fmode ( int* _PMode); typedef struct _div_t { int quot; int rem; } div_t; typedef struct _ldiv_t { long quot; long rem; } ldiv_t; typedef struct _lldiv_t { long long quot; long long rem; } lldiv_t; int __cdecl abs ( int _Number); long __cdecl labs ( long _Number); long long __cdecl llabs ( long long _Number); __int64 __cdecl _abs64( __int64 _Number); unsigned short __cdecl _byteswap_ushort( unsigned short _Number); unsigned long __cdecl _byteswap_ulong ( unsigned long _Number); unsigned __int64 __cdecl _byteswap_uint64( unsigned __int64 _Number); div_t __cdecl div ( int _Numerator, int _Denominator); ldiv_t __cdecl ldiv ( long _Numerator, long _Denominator); lldiv_t __cdecl lldiv( long long _Numerator, long long _Denominator); #pragma warning (push) #pragma warning (disable:6540) unsigned int __cdecl _rotl( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotl( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotl64( unsigned __int64 _Value, int _Shift ); unsigned int __cdecl _rotr( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotr( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotr64( unsigned __int64 _Value, int _Shift ); #pragma warning (pop) void __cdecl srand( unsigned int _Seed); int __cdecl rand(void); extern "C++" { inline long abs(long const _X) throw() { return labs(_X); } inline long long abs(long long const _X) throw() { return llabs(_X); } inline ldiv_t div(long const _A1, long const _A2) throw() { return ldiv(_A1, _A2); } inline lldiv_t div(long long const _A1, long long const _A2) throw() { return lldiv(_A1, _A2); } } #pragma pack(push, 4) typedef struct { unsigned char ld[10]; } _LDOUBLE; #pragma pack(pop) #line 410 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" typedef struct { double x; } _CRT_DOUBLE; typedef struct { float f; } _CRT_FLOAT; typedef struct { long double x; } _LONGDOUBLE; #pragma pack(push, 4) typedef struct { unsigned char ld12[12]; } _LDBL12; #pragma pack(pop) double __cdecl atof ( char const* _String); int __cdecl atoi ( char const* _String); long __cdecl atol ( char const* _String); long long __cdecl atoll ( char const* _String); __int64 __cdecl _atoi64( char const* _String); double __cdecl _atof_l ( char const* _String, _locale_t _Locale); int __cdecl _atoi_l ( char const* _String, _locale_t _Locale); long __cdecl _atol_l ( char const* _String, _locale_t _Locale); long long __cdecl _atoll_l ( char const* _String, _locale_t _Locale); __int64 __cdecl _atoi64_l( char const* _String, _locale_t _Locale); int __cdecl _atoflt ( _CRT_FLOAT* _Result, char const* _String); int __cdecl _atodbl ( _CRT_DOUBLE* _Result, char* _String); int __cdecl _atoldbl( _LDOUBLE* _Result, char* _String); int __cdecl _atoflt_l( _CRT_FLOAT* _Result, char const* _String, _locale_t _Locale ); int __cdecl _atodbl_l( _CRT_DOUBLE* _Result, char* _String, _locale_t _Locale ); int __cdecl _atoldbl_l( _LDOUBLE* _Result, char* _String, _locale_t _Locale ); float __cdecl strtof( char const* _String, char** _EndPtr ); float __cdecl _strtof_l( char const* _String, char** _EndPtr, _locale_t _Locale ); double __cdecl strtod( char const* _String, char** _EndPtr ); double __cdecl _strtod_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long double __cdecl strtold( char const* _String, char** _EndPtr ); long double __cdecl _strtold_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long __cdecl strtol( char const* _String, char** _EndPtr, int _Radix ); long __cdecl _strtol_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl strtoll( char const* _String, char** _EndPtr, int _Radix ); long long __cdecl _strtoll_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl strtoul( char const* _String, char** _EndPtr, int _Radix ); unsigned long __cdecl _strtoul_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl strtoull( char const* _String, char** _EndPtr, int _Radix ); unsigned long long __cdecl _strtoull_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); __int64 __cdecl _strtoi64( char const* _String, char** _EndPtr, int _Radix ); __int64 __cdecl _strtoi64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _strtoui64( char const* _String, char** _EndPtr, int _Radix ); unsigned __int64 __cdecl _strtoui64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); errno_t __cdecl _itoa_s( int _Value, char* _Buffer, size_t _BufferCount, int _Radix ); extern "C++" { template inline errno_t __cdecl _itoa_s(int _Value, char (&_Buffer)[_Size], int _Radix) throw() { return _itoa_s(_Value, _Buffer, _Size, _Radix); } } #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _itoa(int _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _ltoa_s( long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); extern "C++" { template inline errno_t __cdecl _ltoa_s(long _Value, char (&_Buffer)[_Size], int _Radix) throw() { return _ltoa_s(_Value, _Buffer, _Size, _Radix); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ltoa(long _Value, char *_Buffer, int _Radix); errno_t __cdecl _ultoa_s( unsigned long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); extern "C++" { template inline errno_t __cdecl _ultoa_s(unsigned long _Value, char (&_Buffer)[_Size], int _Radix) throw() { return _ultoa_s(_Value, _Buffer, _Size, _Radix); } } #pragma warning(push) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ultoa(unsigned long _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _i64toa_s( __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _i64toa( __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ui64toa_s( unsigned __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ui64toa( unsigned __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ecvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); extern "C++" { template inline errno_t __cdecl _ecvt_s(char (&_Buffer)[_Size], double _Value, int _DigitCount, int* _PtDec, int* _PtSign) throw() { return _ecvt_s(_Buffer, _Size, _Value, _DigitCount, _PtDec, _PtSign); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _fcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); extern "C++" { template inline errno_t __cdecl _fcvt_s(char (&_Buffer)[_Size], double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign) throw() { return _fcvt_s(_Buffer, _Size, _Value, _FractionalDigitCount, _PtDec, _PtSign); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _gcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount ); extern "C++" { template inline errno_t __cdecl _gcvt_s(char (&_Buffer)[_Size], double _Value, int _DigitCount) throw() { return _gcvt_s(_Buffer, _Size, _Value, _DigitCount); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _gcvt( double _Value, int _DigitCount, char* _Buffer ); #line 838 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl ___mb_cur_max_func(void); int __cdecl ___mb_cur_max_l_func(_locale_t _Locale); int __cdecl mblen( char const* _Ch, size_t _MaxCount ); int __cdecl _mblen_l( char const* _Ch, size_t _MaxCount, _locale_t _Locale ); size_t __cdecl _mbstrlen( char const* _String ); size_t __cdecl _mbstrlen_l( char const* _String, _locale_t _Locale ); size_t __cdecl _mbstrnlen( char const* _String, size_t _MaxCount ); size_t __cdecl _mbstrnlen_l( char const* _String, size_t _MaxCount, _locale_t _Locale ); int __cdecl mbtowc( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes ); int __cdecl _mbtowc_l( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes, _locale_t _Locale ); errno_t __cdecl mbstowcs_s( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount ); extern "C++" { template inline errno_t __cdecl mbstowcs_s(size_t* _PtNumOfCharConverted, wchar_t (&_Dest)[_Size], char const* _Source, size_t _MaxCount) throw() { return mbstowcs_s(_PtNumOfCharConverted, _Dest, _Size, _Source, _MaxCount); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "mbstowcs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl mbstowcs( wchar_t *_Dest, char const* _Source, size_t _MaxCount); errno_t __cdecl _mbstowcs_s_l( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount, _locale_t _Locale ); extern "C++" { template inline errno_t __cdecl _mbstowcs_s_l(size_t* _PtNumOfCharConverted, wchar_t (&_Dest)[_Size], char const* _Source, size_t _MaxCount, _locale_t _Locale) throw() { return _mbstowcs_s_l(_PtNumOfCharConverted, _Dest, _Size, _Source, _MaxCount, _Locale); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_mbstowcs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _mbstowcs_l( wchar_t *_Dest, char const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wctomb_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl wctomb( char* _MbCh, wchar_t _WCh ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctomb_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _wctomb_l( char* _MbCh, wchar_t _WCh, _locale_t _Locale ); errno_t __cdecl wctomb_s( int* _SizeConverted, char* _MbCh, rsize_t _SizeInBytes, wchar_t _WCh ); errno_t __cdecl _wctomb_s_l( int* _SizeConverted, char* _MbCh, size_t _SizeInBytes, wchar_t _WCh, _locale_t _Locale); errno_t __cdecl wcstombs_s( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes ); extern "C++" { template inline errno_t __cdecl wcstombs_s(size_t* _PtNumOfCharConverted, char (&_Dest)[_Size], wchar_t const* _Source, size_t _MaxCount) throw() { return wcstombs_s(_PtNumOfCharConverted, _Dest, _Size, _Source, _MaxCount); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstombs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl wcstombs( char *_Dest, wchar_t const* _Source, size_t _MaxCount); errno_t __cdecl _wcstombs_s_l( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes, _locale_t _Locale ); extern "C++" { template inline errno_t __cdecl _wcstombs_s_l(size_t* _PtNumOfCharConverted, char (&_Dest)[_Size], wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale) throw() { return _wcstombs_s_l(_PtNumOfCharConverted, _Dest, _Size, _Source, _MaxCount, _Locale); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcstombs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _wcstombs_l( char *_Dest, wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(allocator) char* __cdecl _fullpath( char* _Buffer, char const* _Path, size_t _BufferCount ); errno_t __cdecl _makepath_s( char* _Buffer, size_t _BufferCount, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext ); extern "C++" { template inline errno_t __cdecl _makepath_s(char (&_Buffer)[_Size], char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext) throw() { return _makepath_s(_Buffer, _Size, _Drive, _Dir, _Filename, _Ext); } } #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_makepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _makepath( char *_Buffer, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext); #pragma warning(pop) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_splitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _splitpath( char const* _FullPath, char* _Drive, char* _Dir, char* _Filename, char* _Ext ); errno_t __cdecl _splitpath_s( char const* _FullPath, char* _Drive, size_t _DriveCount, char* _Dir, size_t _DirCount, char* _Filename, size_t _FilenameCount, char* _Ext, size_t _ExtCount ); extern "C++" { template inline errno_t __cdecl _splitpath_s( char const* _Dest, char (&_Drive)[_DriveSize], char (&_Dir)[_DirSize], char (&_Name)[_NameSize], char (&_Ext)[_ExtSize] ) throw() { return _splitpath_s(_Dest, _Drive, _DriveSize, _Dir, _DirSize, _Name, _NameSize, _Ext, _ExtSize); } } errno_t __cdecl getenv_s( size_t* _RequiredCount, char* _Buffer, rsize_t _BufferCount, char const* _VarName ); int* __cdecl __p___argc (void); char*** __cdecl __p___argv (void); wchar_t*** __cdecl __p___wargv(void); #line 1164 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" char*** __cdecl __p__environ (void); wchar_t*** __cdecl __p__wenviron(void); #line 1181 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "_dupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl getenv( char const* _VarName ); extern "C++" { template inline errno_t __cdecl getenv_s(size_t* _RequiredCount, char (&_Buffer)[_Size], char const* _VarName) throw() { return getenv_s(_RequiredCount, _Buffer, _Size, _VarName); } } errno_t __cdecl _dupenv_s( char** _Buffer, size_t* _BufferCount, char const* _VarName ); int __cdecl system( char const* _Command ); #pragma warning (push) #pragma warning (disable:6540) int __cdecl _putenv( char const* _EnvString ); errno_t __cdecl _putenv_s( char const* _Name, char const* _Value ); #pragma warning (pop) errno_t __cdecl _searchenv_s( char const* _Filename, char const* _VarName, char* _Buffer, size_t _BufferCount ); extern "C++" { template inline errno_t __cdecl _searchenv_s(char const* _Filename, char const* _VarName, char (&_Buffer)[_Size]) throw() { return _searchenv_s(_Filename, _VarName, _Buffer, _Size); } } __declspec(deprecated("This function or variable may be unsafe. Consider using " "_searchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _searchenv(char const* _Filename, char const* _VarName, char *_Buffer); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "SetErrorMode" " " "instead. See online help for details.")) void __cdecl _seterrormode( int _Mode ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Beep" " " "instead. See online help for details.")) void __cdecl _beep( unsigned _Frequency, unsigned _Duration ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Sleep" " " "instead. See online help for details.")) void __cdecl _sleep( unsigned long _Duration ); #pragma warning(push) #pragma warning(disable: 4141) __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ecvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_fcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_gcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl gcvt( double _Value, int _DigitCount, char* _DstBuf ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_itoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl itoa( int _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ltoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ltoa( long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_swab" ". See online help for details.")) void __cdecl swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ultoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ultoa( unsigned long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_putenv" ". See online help for details.")) int __cdecl putenv( char const* _EnvString ); #pragma warning(pop) _onexit_t __cdecl onexit( _onexit_t _Func); } __pragma(pack(pop)) #line 9 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\cstdlib" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 65 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 88 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 128 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" struct _complex { double x,y; } ; #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 65 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 88 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 128 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 137 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\math.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" #pragma once __pragma(pack(push, 8)) extern "C" { #pragma warning(push) #pragma warning(disable:4738) #pragma warning(disable:4820) struct _exception { int type; char* name; double arg1; double arg2; double retval; }; #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" typedef float float_t; typedef double double_t; #line 74 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" extern double const _HUGE; void __cdecl _fperrraise( int _Except); short __cdecl _dclass( double _X); short __cdecl _ldclass( long double _X); short __cdecl _fdclass( float _X); int __cdecl _dsign( double _X); int __cdecl _ldsign( long double _X); int __cdecl _fdsign( float _X); int __cdecl _dpcomp( double _X, double _Y); int __cdecl _ldpcomp( long double _X, long double _Y); int __cdecl _fdpcomp( float _X, float _Y); short __cdecl _dtest( double* _Px); short __cdecl _ldtest( long double* _Px); short __cdecl _fdtest( float* _Px); short __cdecl _d_int( double* _Px, short _Xexp); short __cdecl _ld_int( long double* _Px, short _Xexp); short __cdecl _fd_int( float* _Px, short _Xexp); short __cdecl _dscale( double* _Px, long _Lexp); short __cdecl _ldscale( long double* _Px, long _Lexp); short __cdecl _fdscale( float* _Px, long _Lexp); short __cdecl _dunscale( short* _Pex, double* _Px); short __cdecl _ldunscale( short* _Pex, long double* _Px); short __cdecl _fdunscale( short* _Pex, float* _Px); short __cdecl _dexp( double* _Px, double _Y, long _Eoff); short __cdecl _ldexp( long double* _Px, long double _Y, long _Eoff); short __cdecl _fdexp( float* _Px, float _Y, long _Eoff); short __cdecl _dnorm( unsigned short* _Ps); short __cdecl _fdnorm( unsigned short* _Ps); double __cdecl _dpoly( double _X, double const* _Tab, int _N); long double __cdecl _ldpoly( long double _X, long double const* _Tab, int _N); float __cdecl _fdpoly( float _X, float const* _Tab, int _N); double __cdecl _dlog( double _X, int _Baseflag); long double __cdecl _ldlog( long double _X, int _Baseflag); float __cdecl _fdlog( float _X, int _Baseflag); double __cdecl _dsin( double _X, unsigned int _Qoff); long double __cdecl _ldsin( long double _X, unsigned int _Qoff); float __cdecl _fdsin( float _X, unsigned int _Qoff); typedef union { unsigned short _Sh[4]; double _Val; } _double_val; typedef union { unsigned short _Sh[2]; float _Val; } _float_val; typedef union { unsigned short _Sh[4]; long double _Val; } _ldouble_val; typedef union { unsigned short _Word[4]; float _Float; double _Double; long double _Long_double; } _float_const; extern const _float_const _Denorm_C, _Inf_C, _Nan_C, _Snan_C, _Hugeval_C; extern const _float_const _FDenorm_C, _FInf_C, _FNan_C, _FSnan_C; extern const _float_const _LDenorm_C, _LInf_C, _LNan_C, _LSnan_C; extern const _float_const _Eps_C, _Rteps_C; extern const _float_const _FEps_C, _FRteps_C; extern const _float_const _LEps_C, _LRteps_C; extern const double _Zero_C, _Xbig_C; extern const float _FZero_C, _FXbig_C; extern const long double _LZero_C, _LXbig_C; #line 288 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" extern "C++" { inline int fpclassify( float _X) throw() { return _fdtest(&_X); } inline int fpclassify( double _X) throw() { return _dtest(&_X); } inline int fpclassify( long double _X) throw() { return _ldtest(&_X); } inline bool signbit( float _X) throw() { return _fdsign(_X) != 0; } inline bool signbit( double _X) throw() { return _dsign(_X) != 0; } inline bool signbit( long double _X) throw() { return _ldsign(_X) != 0; } inline int _fpcomp( float _X, float _Y) throw() { return _fdpcomp(_X, _Y); } inline int _fpcomp( double _X, double _Y) throw() { return _dpcomp(_X, _Y); } inline int _fpcomp( long double _X, long double _Y) throw() { return _ldpcomp(_X, _Y); } template struct _Combined_type { typedef float _Type; }; template <> struct _Combined_type { typedef double _Type; }; template <> struct _Combined_type { typedef long double _Type; }; template struct _Real_widened { typedef long double _Type; }; template <> struct _Real_widened { typedef float _Type; }; template <> struct _Real_widened { typedef double _Type; }; template <> struct _Real_widened { typedef double _Type; }; template <> struct _Real_widened { typedef double _Type; }; template struct _Real_type { typedef double _Type; }; template <> struct _Real_type { typedef float _Type; }; template <> struct _Real_type { typedef long double _Type; }; template inline int _fpcomp( _T1 _X, _T2 _Y) throw() { typedef typename _Combined_type::_Type, typename _Real_type<_T2>::_Type>::_Type>::_Type _Tw; return _fpcomp((_Tw)_X, (_Tw)_Y); } template inline bool isfinite( _Ty _X) throw() { return fpclassify(_X) <= 0; } template inline bool isinf( _Ty _X) throw() { return fpclassify(_X) == 1; } template inline bool isnan( _Ty _X) throw() { return fpclassify(_X) == 2; } template inline bool isnormal( _Ty _X) throw() { return fpclassify(_X) == (-1); } template inline bool isgreater( _Ty1 _X, _Ty2 _Y) throw() { return (_fpcomp(_X, _Y) & 4) != 0; } template inline bool isgreaterequal( _Ty1 _X, _Ty2 _Y) throw() { return (_fpcomp(_X, _Y) & (2 | 4)) != 0; } template inline bool isless( _Ty1 _X, _Ty2 _Y) throw() { return (_fpcomp(_X, _Y) & 1) != 0; } template inline bool islessequal( _Ty1 _X, _Ty2 _Y) throw() { return (_fpcomp(_X, _Y) & (1 | 2)) != 0; } template inline bool islessgreater( _Ty1 _X, _Ty2 _Y) throw() { return (_fpcomp(_X, _Y) & (1 | 4)) != 0; } template inline bool isunordered( _Ty1 _X, _Ty2 _Y) throw() { return _fpcomp(_X, _Y) == 0; } } int __cdecl abs( int _X); long __cdecl labs( long _X); long long __cdecl llabs( long long _X); double __cdecl acos( double _X); double __cdecl asin( double _X); double __cdecl atan( double _X); double __cdecl atan2( double _Y, double _X); double __cdecl cos( double _X); double __cdecl cosh( double _X); double __cdecl exp( double _X); double __cdecl fabs( double _X); double __cdecl fmod( double _X, double _Y); double __cdecl log( double _X); double __cdecl log10( double _X); double __cdecl pow( double _X, double _Y); double __cdecl sin( double _X); double __cdecl sinh( double _X); double __cdecl sqrt( double _X); double __cdecl tan( double _X); double __cdecl tanh( double _X); double __cdecl acosh( double _X); double __cdecl asinh( double _X); double __cdecl atanh( double _X); double __cdecl atof( char const* _String); double __cdecl _atof_l( char const* _String, _locale_t _Locale); double __cdecl _cabs( struct _complex _Complex_value); double __cdecl cbrt( double _X); double __cdecl ceil( double _X); double __cdecl _chgsign( double _X); double __cdecl copysign( double _Number, double _Sign); double __cdecl _copysign( double _Number, double _Sign); double __cdecl erf( double _X); double __cdecl erfc( double _X); double __cdecl exp2( double _X); double __cdecl expm1( double _X); double __cdecl fdim( double _X, double _Y); double __cdecl floor( double _X); double __cdecl fma( double _X, double _Y, double _Z); double __cdecl fmax( double _X, double _Y); double __cdecl fmin( double _X, double _Y); double __cdecl frexp( double _X, int* _Y); double __cdecl hypot( double _X, double _Y); double __cdecl _hypot( double _X, double _Y); int __cdecl ilogb( double _X); double __cdecl ldexp( double _X, int _Y); double __cdecl lgamma( double _X); long long __cdecl llrint( double _X); long long __cdecl llround( double _X); double __cdecl log1p( double _X); double __cdecl log2( double _X); double __cdecl logb( double _X); long __cdecl lrint( double _X); long __cdecl lround( double _X); int __cdecl _matherr( struct _exception* _Except); double __cdecl modf( double _X, double* _Y); double __cdecl nan( char const* _X); double __cdecl nearbyint( double _X); double __cdecl nextafter( double _X, double _Y); double __cdecl nexttoward( double _X, long double _Y); double __cdecl remainder( double _X, double _Y); double __cdecl remquo( double _X, double _Y, int* _Z); double __cdecl rint( double _X); double __cdecl round( double _X); double __cdecl scalbln( double _X, long _Y); double __cdecl scalbn( double _X, int _Y); double __cdecl tgamma( double _X); double __cdecl trunc( double _X); double __cdecl _j0( double _X ); double __cdecl _j1( double _X ); double __cdecl _jn(int _X, double _Y); double __cdecl _y0( double _X); double __cdecl _y1( double _X); double __cdecl _yn( int _X, double _Y); float __cdecl acoshf( float _X); float __cdecl asinhf( float _X); float __cdecl atanhf( float _X); float __cdecl cbrtf( float _X); float __cdecl _chgsignf( float _X); float __cdecl copysignf( float _Number, float _Sign); float __cdecl _copysignf( float _Number, float _Sign); float __cdecl erff( float _X); float __cdecl erfcf( float _X); float __cdecl expm1f( float _X); float __cdecl exp2f( float _X); float __cdecl fdimf( float _X, float _Y); float __cdecl fmaf( float _X, float _Y, float _Z); float __cdecl fmaxf( float _X, float _Y); float __cdecl fminf( float _X, float _Y); float __cdecl _hypotf( float _X, float _Y); int __cdecl ilogbf( float _X); float __cdecl lgammaf( float _X); long long __cdecl llrintf( float _X); long long __cdecl llroundf( float _X); float __cdecl log1pf( float _X); float __cdecl log2f( float _X); float __cdecl logbf( float _X); long __cdecl lrintf( float _X); long __cdecl lroundf( float _X); float __cdecl nanf( char const* _X); float __cdecl nearbyintf( float _X); float __cdecl nextafterf( float _X, float _Y); float __cdecl nexttowardf( float _X, long double _Y); float __cdecl remainderf( float _X, float _Y); float __cdecl remquof( float _X, float _Y, int* _Z); float __cdecl rintf( float _X); float __cdecl roundf( float _X); float __cdecl scalblnf( float _X, long _Y); float __cdecl scalbnf( float _X, int _Y); float __cdecl tgammaf( float _X); float __cdecl truncf( float _X); float __cdecl _logbf( float _X); float __cdecl _nextafterf( float _X, float _Y); int __cdecl _finitef( float _X); int __cdecl _isnanf( float _X); int __cdecl _fpclassf( float _X); int __cdecl _set_FMA3_enable( int _Flag); int __cdecl _get_FMA3_enable(void); #line 606 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" float __cdecl acosf( float _X); float __cdecl asinf( float _X); float __cdecl atan2f( float _Y, float _X); float __cdecl atanf( float _X); float __cdecl ceilf( float _X); float __cdecl cosf( float _X); float __cdecl coshf( float _X); float __cdecl expf( float _X); #line 663 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" __inline float __cdecl __MS_fabsf( float _X) { return (float)fabs(_X); } float __cdecl floorf( float _X); float __cdecl fmodf( float _X, float _Y); #line 695 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" __inline float __cdecl __MS_frexpf( float _X, int *_Y) { return (float)frexp(_X, _Y); } __inline float __cdecl __MS_hypotf( float _X, float _Y) { return _hypotf(_X, _Y); } __inline float __cdecl __MS_ldexpf( float _X, int _Y) { return (float)ldexp(_X, _Y); } float __cdecl log10f( float _X); float __cdecl logf( float _X); float __cdecl modff( float _X, float *_Y); float __cdecl powf( float _X, float _Y); float __cdecl sinf( float _X); float __cdecl sinhf( float _X); float __cdecl sqrtf( float _X); float __cdecl tanf( float _X); float __cdecl tanhf( float _X); #line 774 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" long double __cdecl acoshl( long double _X); __inline long double __cdecl __MS_acosl( long double _X) { return acos((double)_X); } long double __cdecl asinhl( long double _X); __inline long double __cdecl __MS_asinl( long double _X) { return asin((double)_X); } __inline long double __cdecl __MS_atan2l( long double _Y, long double _X) { return atan2((double)_Y, (double)_X); } long double __cdecl atanhl( long double _X); __inline long double __cdecl __MS_atanl( long double _X) { return atan((double)_X); } long double __cdecl cbrtl( long double _X); __inline long double __cdecl __MS_ceill( long double _X) { return ceil((double)_X); } __inline long double __cdecl _chgsignl( long double _X) { return _chgsign((double)_X); } long double __cdecl copysignl( long double _Number, long double _Sign); __inline long double __cdecl _copysignl( long double _Number, long double _Sign) { return _copysign((double)_Number, (double)_Sign); } __inline long double __cdecl __MS_coshl( long double _X) { return cosh((double)_X); } __inline long double __cdecl __MS_cosl( long double _X) { return cos((double)_X); } long double __cdecl erfl( long double _X); long double __cdecl erfcl( long double _X); __inline long double __cdecl __MS_expl( long double _X) { return exp((double)_X); } long double __cdecl exp2l( long double _X); long double __cdecl expm1l( long double _X); __inline long double __cdecl __MS_fabsl( long double _X) { return fabs((double)_X); } long double __cdecl fdiml( long double _X, long double _Y); __inline long double __cdecl __MS_floorl( long double _X) { return floor((double)_X); } long double __cdecl fmal( long double _X, long double _Y, long double _Z); long double __cdecl fmaxl( long double _X, long double _Y); long double __cdecl fminl( long double _X, long double _Y); __inline long double __cdecl __MS_fmodl( long double _X, long double _Y) { return fmod((double)_X, (double)_Y); } __inline long double __cdecl __MS_frexpl( long double _X, int *_Y) { return frexp((double)_X, _Y); } int __cdecl ilogbl( long double _X); __inline long double __cdecl _hypotl( long double _X, long double _Y) { return _hypot((double)_X, (double)_Y); } __inline long double __cdecl __MS_hypotl( long double _X, long double _Y) { return _hypot((double)_X, (double)_Y); } __inline long double __cdecl __MS_ldexpl( long double _X, int _Y) { return ldexp((double)_X, _Y); } long double __cdecl lgammal( long double _X); long long __cdecl llrintl( long double _X); long long __cdecl llroundl( long double _X); __inline long double __cdecl __MS_logl( long double _X) { return log((double)_X); } __inline long double __cdecl __MS_log10l( long double _X) { return log10((double)_X); } long double __cdecl log1pl( long double _X); long double __cdecl log2l( long double _X); long double __cdecl logbl( long double _X); long __cdecl lrintl( long double _X); long __cdecl lroundl( long double _X); __inline long double __cdecl __MS_modfl( long double _X, long double* _Y) { double _F, _I; _F = modf((double)_X, &_I); *_Y = _I; return _F; } long double __cdecl nanl( char const* _X); long double __cdecl nearbyintl( long double _X); long double __cdecl nextafterl( long double _X, long double _Y); long double __cdecl nexttowardl( long double _X, long double _Y); __inline long double __cdecl __MS_powl( long double _X, long double _Y) { return pow((double)_X, (double)_Y); } long double __cdecl remainderl( long double _X, long double _Y); long double __cdecl remquol( long double _X, long double _Y, int* _Z); long double __cdecl rintl( long double _X); long double __cdecl roundl( long double _X); long double __cdecl scalblnl( long double _X, long _Y); long double __cdecl scalbnl( long double _X, int _Y); __inline long double __cdecl __MS_sinhl( long double _X) { return sinh((double)_X); } __inline long double __cdecl __MS_sinl( long double _X) { return sin((double)_X); } __inline long double __cdecl __MS_sqrtl( long double _X) { return sqrt((double)_X); } __inline long double __cdecl __MS_tanhl( long double _X) { return tanh((double)_X); } __inline long double __cdecl __MS_tanl( long double _X) { return tan((double)_X); } long double __cdecl tgammal( long double _X); long double __cdecl truncl( long double _X); #line 971 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" extern double HUGE; __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_j0" ". See online help for details.")) double __cdecl j0( double _X); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_j1" ". See online help for details.")) double __cdecl j1( double _X); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_jn" ". See online help for details.")) double __cdecl jn( int _X, double _Y); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_y0" ". See online help for details.")) double __cdecl y0( double _X); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_y1" ". See online help for details.")) double __cdecl y1( double _X); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_yn" ". See online help for details.")) double __cdecl yn( int _X, double _Y); #pragma warning(pop) } __pragma(pack(pop)) #line 12 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\math.h" #line 142 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 176 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 226 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math_common_define.h" #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math_common_define.h" #line 39 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math_common_define.h" #line 59 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math_common_define.h" #line 231 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 245 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 271 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 285 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 307 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 354 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 370 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern "C" int fpclassifyf ( float __x ) throw(); extern "C" int fpclassifyd ( double __x ) throw(); extern "C" int fpclassifyl ( long double __x ) throw(); extern "C" int isinff ( float __x ) throw(); extern "C" int isinfd ( double __x ) throw(); extern "C" int isinfl ( long double __x ) throw(); extern "C" int isnanf ( float __x ) throw(); extern "C" int isnand ( double __x ) throw(); extern "C" int isnanl ( long double __x ) throw(); extern "C" int isnormalf ( float __x ) throw(); extern "C" int isnormald ( double __x ) throw(); extern "C" int isnormall ( long double __x ) throw(); extern "C" int isfinitef ( float __x ) throw(); extern "C" int isfinited ( double __x ) throw(); extern "C" int isfinitel ( long double __x ) throw(); extern "C" int finitef ( float __x ) throw(); extern "C" int finite ( double __x ) throw(); extern "C" int finited ( double __x ) throw(); extern "C" int finitel ( long double __x ) throw(); extern "C" int signbitf ( float __x ) throw(); extern "C" int signbitd ( double __x ) throw(); extern "C" int signbitl ( long double __x ) throw(); extern "C" int __fpclassifyf ( float __x ) throw(); extern "C" int __fpclassify ( double __x ) throw(); extern "C" int __fpclassifyd ( double __x ) throw(); extern "C" int __fpclassifyl ( long double __x ) throw(); extern "C" int __isinff ( float __x ) throw(); extern "C" int __isinf ( double __x ) throw(); extern "C" int __isinfd ( double __x ) throw(); extern "C" int __isinfl ( long double __x ) throw(); extern "C" int __isnanf ( float __x ) throw(); extern "C" int __isnan ( double __x ) throw(); extern "C" int __isnand ( double __x ) throw(); extern "C" int __isnanl ( long double __x ) throw(); extern "C" int __isnormalf ( float __x ) throw(); extern "C" int __isnormal ( double __x ) throw(); extern "C" int __isnormald ( double __x ) throw(); extern "C" int __isnormall ( long double __x ) throw(); extern "C" int __isfinitef ( float __x ) throw(); extern "C" int __isfinite ( double __x ) throw(); extern "C" int __isfinited ( double __x ) throw(); extern "C" int __isfinitel ( long double __x ) throw(); extern "C" int __finitef ( float __x ) throw(); extern "C" int __finite ( double __x ) throw(); extern "C" int __finited ( double __x ) throw(); extern "C" int __finitel ( long double __x ) throw(); extern "C" int __signbitf ( float __x ) throw(); extern "C" int __signbit ( double __x ) throw(); extern "C" int __signbitd ( double __x ) throw(); extern "C" int __signbitl ( long double __x ) throw(); #line 470 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 487 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 520 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern "C" int isgreaterf( float __xf, float __yf ); extern "C" int isgreaterl( long double __xl, long double __yl ); extern "C" int __isgreaterf( float __xf, float __yf ); extern "C" int __isgreater( double __xd, double __yd ); extern "C" int __isgreaterl( long double __xl, long double __yl ); extern "C" int isgreaterequalf( float __xf, float __yf ); extern "C" int isgreaterequall( long double __xl, long double __yl ); extern "C" int __isgreaterequalf( float __xf, float __yf ); extern "C" int __isgreaterequal( double __xd, double __yd ); extern "C" int __isgreaterequall( long double __xl, long double __yl ); extern "C" int islessf( float __xf, float __yf ); extern "C" int islessl( long double __xl, long double __yl ); extern "C" int __islessf( float __xf, float __yf ); extern "C" int __isless( double __xd, double __yd ); extern "C" int __islessl( long double __xl, long double __yl ); int islessequalf( float __xf, float __yf ); extern "C" int islessequall( long double __xl, long double __yl ); extern "C" int __islessequalf( float __xf, float __yf ); extern "C" int __islessequal( double __xd, double __yd ); extern "C" int __islessequall( long double __xl, long double __yl ); extern "C" int islessgreaterf( float __xf, float __yf ); extern "C" int islessgreaterl( long double __xl, long double __yl ); extern "C" int __islessgreaterf( float __xf, float __yf ); extern "C" int __islessgreater( double __xd, double __yd ); extern "C" int __islessgreaterl( long double __xl, long double __yl ); extern "C" int isunorderedf( float __xf, float __yf ); extern "C" int isunorderedl( long double __xl, long double __yl ); extern "C" int __isunorderedf( float __xf, float __yf ); extern "C" int __isunordered( double __xd, double __yd ); extern "C" int __isunorderedl( long double __xl, long double __yl ); #line 584 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 597 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 612 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern "C" float __cdecl acosf( float __x ); extern "C" float __cdecl asinf( float __x ); extern "C" float __cdecl atanf( float __x ); extern "C" float __cdecl atan2f( float __y, float __x ); extern "C" float __cdecl cosf( float __x ); extern "C" float __cdecl sinf( float __x ); extern "C" float __cdecl tanf( float __x ); extern "C" double __cdecl acosh( double __x ); extern "C" float __cdecl acoshf( float __x ); extern "C" double __cdecl asinh( double __x ); extern "C" float __cdecl asinhf( float __x ); extern "C" double __cdecl atanh( double __x ); extern "C" float __cdecl atanhf( float __x ); #line 647 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern "C" float __cdecl coshf( float __x ); extern "C" float __cdecl sinhf( float __x ); extern "C" float __cdecl tanhf( float __x ); extern "C" float __cdecl expf( float __x ); extern "C" double __cdecl expm1( double __x ); extern "C" float __cdecl expm1f( float __x ); extern "C" double __cdecl exp2( double __x ); extern "C" float __cdecl exp2f( float __x ); #line 688 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern "C" float __cdecl frexpf( float __x, int *__exp ); extern "C" float __cdecl ldexpf( float __x, int __exp ); extern "C" float __cdecl nanf( const char* __tagp ); extern "C" double __cdecl nan ( const char* __tagp ); extern "C" long double __cdecl nanl( const char* __tagp ); extern "C" double __cdecl scalb( double __x, double __y ); extern "C" float __cdecl scalbf( float __x, float __y ); extern "C" double __cdecl scalbn( double __x, int __n ); extern "C" float __cdecl scalbnf( float __x, int __n ); extern "C" double __cdecl scalbln( double __x, long int __n ); extern "C" float __cdecl scalblnf( float __x, long int __n ); #line 728 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern "C" float __cdecl logf( float __x ); extern "C" float __cdecl log10f( float __x ); extern "C" double __cdecl log2( double __x ); extern "C" float __cdecl log2f( float __x ); extern "C" double __cdecl log1p( double __x ); extern "C" float __cdecl log1pf( float __x ); extern "C" double __cdecl logb( double __x ); extern "C" float __cdecl logbf( float __x ); extern "C" int __cdecl ilogb( double __x ); extern "C" int __cdecl ilogbf( float __x ); extern "C" float __cdecl modff( float __x, float *__iptr ); extern "C" double __cdecl cbrt( double __x ); extern "C" float __cdecl cbrtf( float __x ); #line 780 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern "C" float __cdecl fabsf( float __x ); extern "C" double __cdecl hypot( double __x, double __y ); extern "C" float __cdecl hypotf( float __x, float __y ); extern "C" float __cdecl powf( float __x, float __y ); extern "C" float __cdecl sqrtf( float __x ); extern "C" double __cdecl erf( double __x ); extern "C" float __cdecl erff( float __x ); extern "C" double __cdecl erfc( double __x ); extern "C" float __cdecl erfcf( float __x ); extern "C" double __cdecl lgamma( double __x ); extern "C" float __cdecl lgammaf( float __x ); extern "C" double __cdecl gamma( double __x ); extern "C" float __cdecl gammaf( float __x ); extern "C" double __cdecl lgamma_r(double __x, int *__signgam); extern "C" float __cdecl lgammaf_r( float __x, int *__signgam ); extern "C" double __cdecl gamma_r( double __x, int *__signgam ); extern "C" float __cdecl gammaf_r( float __x, int *__signgam ); extern "C" double __cdecl tgamma( double __x ); extern "C" float __cdecl tgammaf( float __x ); #line 829 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern "C" float __cdecl ceilf( float __x ); extern "C" float __cdecl floorf( float __x ); extern "C" double __cdecl nearbyint( double __x ); extern "C" float __cdecl nearbyintf( float __x ); extern "C" double __cdecl rint( double __x ); extern "C" float __cdecl rintf( float __x ); extern "C" long int __cdecl lrint( double __x ); extern "C" long int __cdecl lrintf( float __x ); extern "C" long long int __cdecl llrint( double __x ); extern "C" long long int __cdecl llrintf( float __x ); extern "C" double __cdecl round( double __x ); extern "C" float __cdecl roundf( float __x ); extern "C" long int __cdecl lround( double __x ); extern "C" long int __cdecl lroundf( float __x ); extern "C" long long int __cdecl llround( double __x ); extern "C" long long int __cdecl llroundf( float __x ); extern "C" double __cdecl trunc( double __x ); extern "C" float __cdecl truncf( float __x ); extern "C" float __cdecl fmodf( float __x, float __y ); extern "C" double __cdecl remainder( double __x, double __y ); extern "C" float __cdecl remainderf( float __x, float __y ); extern "C" double __cdecl remquo( double __x, double __y, int *__quo ); extern "C" float __cdecl remquof( float __x, float __y, int *__quo ); extern "C" double __cdecl copysign( double __x, double __y ); extern "C" float __cdecl copysignf( float __x, float __y ); extern "C" double __cdecl nextafter( double __x, double __y ); extern "C" float __cdecl nextafterf( float __x, float __y ); extern "C" double __cdecl __libm_nexttoward64 ( double __x, long double __y ); extern "C" float __cdecl __libm_nexttoward64f( float __x, double __y ); extern "C" double __cdecl __libm_nexttoward64l( double __x, double __y ); extern "C" double __cdecl fdim( double __x, double __y ); extern "C" float __cdecl fdimf( float __x, float __y ); extern "C" double __cdecl fmax( double __x, double __y ); extern "C" float __cdecl fmaxf( float __x, float __y ); extern "C" double __cdecl fmin( double __x, double __y ); extern "C" float __cdecl fminf( float __x, float __y ); extern "C" double __cdecl fma( double __x, double __y, double __z ); extern "C" float __cdecl fmaf( float __x, float __y, float __z ); extern "C" __forceinline long double __cdecl acosl( long double __x ) {return (long double) acos((double) __x);} extern "C" __forceinline long double __cdecl asinl( long double __x ) {return (long double) asin((double) __x);} extern "C" __forceinline long double __cdecl atan2l( long double __y, long double __x ) {return (long double) atan2((double)__y, (double) __x );} extern "C" __forceinline long double __cdecl atanl( long double __x ) {return (long double) atan((double) __x);} extern "C" __forceinline long double __cdecl ceill( long double __x ) {return (long double) ceil((double) __x);} extern "C" __forceinline long double __cdecl cosl( long double __x ) {return (long double) cos((double) __x);} extern "C" __forceinline long double __cdecl coshl( long double __x ) {return (long double) cosh((double) __x);} extern "C" __forceinline long double __cdecl expl( long double __x ) {return (long double) exp((double) __x);} extern "C" __forceinline long double __cdecl fabsl( long double __x ) {return (long double) fabs((double) __x);} extern "C" __forceinline long double __cdecl floorl( long double __x ) {return (long double) floor((double) __x);} extern "C" __forceinline long double __cdecl fmodl( long double __x, long double __y ) {return (long double) fmod((double)__x, (double) __y );} extern "C" __forceinline long double __cdecl frexpl( long double __x, int *__exp ) {return (long double) frexp((double)__x, __exp );} extern "C" __forceinline long double __cdecl hypotl( long double __x, long double __y ) {return (long double) hypot((double)__x, (double) __y );} extern "C" __forceinline long double __cdecl ldexpl( long double __x, int __exp ) {return (long double) ldexp((double)__x, __exp );} extern "C" __forceinline long double __cdecl logl( long double __x ) {return (long double) log((double) __x);} extern "C" __forceinline long double __cdecl log10l( long double __x ) {return (long double) log10((double) __x);} extern "C" __forceinline long double __cdecl modfl( long double __x, long double *__iptr ) {return (long double) modf((double)__x, (double *) __iptr );} extern "C" __forceinline long double __cdecl powl( long double __x, long double __y ) {return (long double) pow((double)__x, (double) __y );} extern "C" __forceinline long double __cdecl sinhl( long double __x ) {return (long double) sinh((double) __x);} extern "C" __forceinline long double __cdecl sinl( long double __x ) {return (long double) sin((double) __x);} extern "C" __forceinline long double __cdecl sqrtl( long double __x ) {return (long double) sqrt((double) __x);} extern "C" __forceinline long double __cdecl tanl( long double __x ) {return (long double) tan((double) __x);} extern "C" __forceinline long double __cdecl tanhl( long double __x ) {return (long double) tanh((double) __x);} extern "C" __forceinline long double __cdecl acoshl( long double __x ) {return (long double) acosh((double) __x);} extern "C" __forceinline long double __cdecl asinhl( long double __x ) {return (long double) asinh((double) __x);} extern "C" __forceinline long double __cdecl atanhl( long double __x ) {return (long double) atanh((double) __x);} extern "C" __forceinline long double __cdecl cbrtl( long double __x ) {return (long double) cbrt((double) __x);} extern "C" __forceinline long double __cdecl copysignl( long double __x, long double __y ) {return (long double) copysign((double)__x, (double) __y );} extern "C" __forceinline long double __cdecl erfcl( long double __x ) {return (long double) erfc((double) __x);} extern "C" __forceinline long double __cdecl erfl( long double __x ) {return (long double) erf((double) __x);} extern "C" __forceinline int __cdecl ilogbl( long double __x ) {return (long double) ilogb((double) __x);} extern "C" __forceinline long double __cdecl gammal( long double __x ) {return (long double) gamma((double) __x);} extern "C" __forceinline long double __cdecl gammal_r( long double __x, int *__signgam ) {return (long double) gamma_r((double) __x, __signgam);} extern "C" __forceinline long double __cdecl lgammal( long double __x ) {return (long double) lgamma((double) __x);} extern "C" __forceinline long double __cdecl lgammal_r( long double __x, int *__signgam ) {return (long double) lgamma_r((double) __x, __signgam);} extern "C" __forceinline long double __cdecl log1pl( long double __x ) {return (long double) log1p((double) __x);} extern "C" __forceinline long double __cdecl logbl( long double __x ) {return (long double) logb((double) __x);} extern "C" __forceinline long double __cdecl nextafterl( long double __x, long double __y ) {return (long double) nextafter((double)__x, (double) __y );} extern "C" __forceinline long double __cdecl remainderl( long double __x, long double __y ) {return (long double) remainder((double)__x, (double) __y );} extern "C" __forceinline long double __cdecl rintl( long double __x ) {return (long double) rint((double) __x);} extern "C" __forceinline long double __cdecl scalbnl( long double __x, int __n ) {return (long double) scalbn((double)__x, __n );} extern "C" __forceinline long double __cdecl exp2l( long double __x ) {return (long double) exp2((double) __x);} extern "C" __forceinline long double __cdecl expm1l( long double __x ) {return (long double) expm1((double) __x);} extern "C" __forceinline long double __cdecl fdiml( long double __x, long double __y ) {return (long double) fdim((double)__x, (double) __y );} extern "C" __forceinline long double __cdecl fmal( long double __x, long double __y, long double __z ) {return (long double) fma((double) __x, (double) __y, (double) __z);} extern "C" __forceinline long double __cdecl fmaxl( long double __x, long double __y ) {return (long double) fmax((double)__x, (double) __y );} extern "C" __forceinline long double __cdecl fminl( long double __x, long double __y ) {return (long double) fmin((double)__x, (double) __y );} extern "C" __forceinline long long int __cdecl llrintl( long double __x ) {return (long double) llrint((double) __x);} extern "C" __forceinline long long int __cdecl llroundl( long double __x ) {return (long double) llround((double) __x);} extern "C" __forceinline long double __cdecl log2l( long double __x ) {return (long double) log2((double) __x);} extern "C" __forceinline long int __cdecl lrintl( long double __x ) {return (long double) lrint((double) __x);} extern "C" __forceinline long int __cdecl lroundl( long double __x ) {return (long double) lround((double) __x);} extern "C" __forceinline long double __cdecl nearbyintl( long double __x ) {return (long double) nearbyint((double) __x);} extern "C" __forceinline long double __cdecl nexttowardl( long double __x, long double __y ) {return (long double) __libm_nexttoward64l((double)__x, (double) __y );} extern "C" __forceinline double __cdecl nexttoward( double __x, long double __y ) {return __libm_nexttoward64l(__x, (double) __y );} extern "C" __forceinline float __cdecl nexttowardf( float __x, long double __y ) {return __libm_nexttoward64f(__x, (double) __y );} extern "C" __forceinline long double __cdecl remquol( long double __x, long double __y, int *__quo ) {return (long double) remquo((double) __x, (double) __y, __quo);} extern "C" __forceinline long double __cdecl roundl( long double __x ) {return (long double) round((double) __x);} extern "C" __forceinline long double __cdecl scalbl( long double __x, long double __y ) {return (long double) scalb((double)__x, (double) __y );} extern "C" __forceinline long double __cdecl scalblnl( long double __x, long int __n ) {return (long double) scalbln((double)__x, __n );} extern "C" __forceinline long double __cdecl tgammal( long double __x ) {return (long double) tgamma((double) __x);} extern "C" __forceinline long double __cdecl truncl( long double __x ) {return (long double) trunc((double) __x);} #line 1133 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 1147 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" typedef struct ____exception { int type; const char *name; double arg1; double arg2; double retval; } ___exception; #line 1168 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" typedef struct ____exceptionf { int type; const char *name; float arg1; float arg2; float retval; } ___exceptionf; typedef struct ____exceptionl { int type; const char *name; long double arg1; long double arg2; long double retval; } ___exceptionl; extern "C" int __cdecl matherrf( struct ____exceptionf *__e ); extern "C" int __cdecl matherrl( struct ____exceptionl *__e ); typedef int ( __cdecl *___pmatherr )( struct ____exception *__e ); typedef int ( __cdecl *___pmatherrf )( struct ____exceptionf *__e ); typedef int ( __cdecl *___pmatherrl )( struct ____exceptionl *__e ); extern "C" ___pmatherr __cdecl __libm_setusermatherr( ___pmatherr __user_matherr ); extern "C" ___pmatherrf __cdecl __libm_setusermatherrf( ___pmatherrf __user_matherrf ); extern "C" ___pmatherrl __cdecl __libm_setusermatherrl( ___pmatherrl __user_matherrl ); typedef enum ___LIB_VERSIONIMF_TYPE { _IEEE_ = -1 ,_SVID_ ,_XOPEN_ ,_POSIX_ ,_ISOC_ } _LIB_VERSIONIMF_TYPE; extern "C" _LIB_VERSIONIMF_TYPE _LIB_VERSIONIMF; #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math_common_undefine.h" #line 1234 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 142 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 176 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 226 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 10 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\cstdlib" #pragma pack(push,8) #pragma warning(push,3) #pragma warning(disable: 4455 4494 4619 4643 4702 4984 4988) inline double abs( double _Xx) noexcept { return (:: fabs(_Xx)); } inline float abs( float _Xx) noexcept { return (:: fabsf(_Xx)); } inline long double abs( long double _Xx) noexcept { return (:: fabsl(_Xx)); } namespace std { using :: size_t; using :: div_t; using :: ldiv_t; using :: abort; using :: abs; using :: atexit; using :: atof; using :: atoi; using :: atol; using :: bsearch; using :: calloc; using :: div; using :: exit; using :: free; using :: labs; using :: ldiv; using :: malloc; using :: mblen; using :: mbstowcs; using :: mbtowc; using :: qsort; using :: rand; using :: realloc; using :: srand; using :: strtod; using :: strtol; using :: strtoul; using :: wcstombs; using :: wctomb; using :: lldiv_t; using :: getenv; using :: system; using :: atoll; using :: llabs; using :: lldiv; using :: strtof; using :: strtold; using :: strtoll; using :: strtoull; using :: _Exit; using :: at_quick_exit; using :: quick_exit; } #pragma warning(pop) #pragma pack(pop) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.setCompilers\\conftest.cc" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Popping language Cxx ================================================================================ TEST checkFortranCompiler from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:967) TESTING: checkFortranCompiler from config.setCompilers(config/BuildSystem/config/setCompilers.py:967) Locate a functional Fortran compiler Checking for program /usr/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/bin/intel64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.15.26726/bin/HostX64/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/VC/VCPackages/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/TypeScript/3.0/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TestWindow/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TeamFoundation/Team Explorer/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/Roslyn/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/Windows/v10.0A/bin/NETFX 4.6.1 Tools/x64/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/HTML Help Workshop/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/10.0.17134.0/x64/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/win32fe...not found Checking for program /cygdrive/c/Windows/Microsoft.NET/Framework64/v4.0.30319/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/Tools/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/gdb/intel64/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/libipt/intel64/lib/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/ipp/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/daal/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/tbb/vc_mt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Oracle/Java/javapath/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries_2018.3.210/windows/mpi/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/compiler/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/compiler/win32fe...not found Checking for program /cygdrive/e/Python37/Scripts/win32fe...not found Checking for program /cygdrive/e/Python37/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/mpi/2018.1.156/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files/Microsoft MPI/Bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI-RT/4.1.3.045/em64t/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/CMG/CMGJobService/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.3.050/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/mpirt/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/compiler/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/compiler/win32fe...not found Checking for program /cygdrive/c/ProgramData/Oracle/Java/javapath/win32fe...not found Checking for program /cygdrive/c/Python27/win32fe...not found Checking for program /cygdrive/c/Python27/Scripts/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.2.044/intel64/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Composer XE 2015/bin/ia32/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86_64/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86/win32fe...not found Checking for program /cygdrive/c/Progra/win32fe...not found Checking for program /cygdrive/c/Windows/System32/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft Visual Studio 14.0/Common7/IDE/win32fe...not found Checking for program /cygdrive/e/Program Files/PuTTY/win32fe...not found Checking for program /cygdrive/c/ecl/HOME/win32fe...not found Checking for program /cygdrive/c/ecl/MACROS/win32fe...not found Checking for program /cygdrive/e/Program Files/CMake/bin/win32fe...not found Checking for program /cygdrive/e/ecl/HOME/win32fe...not found Checking for program /cygdrive/e/ecl/MACROS/win32fe...not found Checking for program /cygdrive/c/Program Files/dotnet/win32fe...not found Checking for program /cygdrive/c/Program Files/Microsoft SQL Server/130/Tools/Binn/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.14.26428/bin/Hostx64/x64/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/IncrediBuild/win32fe...not found Checking for program /cygdrive/e/Python36/Scripts/win32fe...not found Checking for program /cygdrive/e/Python36/win32fe...not found Checking for program /cygdrive/c/Users/AliReza/.dnx/bin/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/dll/win32fe...not found Checking for program /cygdrive/c/Program Files (x86)/SSH Communications Security/SSH Secure Shell/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/CMake/bin/win32fe...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/Ninja/win32fe...not found Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe...found Defined make macro "FC" to "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort" Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main end Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main end Pushing language C Popping language C Pushing language CUDA Popping language CUDA Pushing language Cxx Popping language Cxx Pushing language FC Popping language FC Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -lpetsc-ufod4vtr9mqHvKIQiVAm stdout: ipo: error #11018: Cannot open libpetsc-ufod4vtr9mqHvKIQiVAm.lib LINK : fatal error LNK1181: cannot open input file 'libpetsc-ufod4vtr9mqHvKIQiVAm.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libpetsc-ufod4vtr9mqHvKIQiVAm.lib LINK : fatal error LNK1181: cannot open input file 'libpetsc-ufod4vtr9mqHvKIQiVAm.lib'Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe Popping language FC ================================================================================ TEST checkFortranComments from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:988) TESTING: checkFortranComments from config.setCompilers(config/BuildSystem/config/setCompilers.py:988) Make sure fortran comment "!" works Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main ! comment end Fortran comments can use ! in column 1 Popping language FC ================================================================================ TEST checkLargeFileIO from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1106) TESTING: checkLargeFileIO from config.setCompilers(config/BuildSystem/config/setCompilers.py:1106) ================================================================================ TEST checkArchiver from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1205) TESTING: checkArchiver from config.setCompilers(config/BuildSystem/config/setCompilers.py:1205) Check that the archiver exists and can make a library usable by the compiler Pushing language C Executing: ar -V stdout: GNU ar (GNU Binutils) 2.29.1.20171006 Copyright (C) 2017 Free Software Foundation, Inc. This program is free software; you may redistribute it under the terms of the GNU General Public License version 3 or (at your option) any later version. This program has absolutely no warranty. Executing: ar -V stdout: GNU ar (GNU Binutils) 2.29.1.20171006 Copyright (C) 2017 Free Software Foundation, Inc. This program is free software; you may redistribute it under the terms of the GNU General Public License version 3 or (at your option) any later version. This program has absolutely no warranty. Defined make macro "FAST_AR_FLAGS" to "Scq" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int foo(int a) { return a+1; } Checking for program /usr/bin/ar...found Defined make macro "AR" to "/usr/bin/ar" Checking for program /usr/bin/ranlib...found Defined make macro "RANLIB" to "/usr/bin/ranlib -c" Executing: /usr/bin/ar cr /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconf1.a /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conf1.o Executing: /usr/bin/ranlib -c /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconf1.a Possible ERROR while running ranlib: stderr: /usr/bin/ranlib: invalid option -- c Ranlib is not functional with your archiver. Try --with-ranlib=true if ranlib is unnecessary. Executing: ar -V stdout: GNU ar (GNU Binutils) 2.29.1.20171006 Copyright (C) 2017 Free Software Foundation, Inc. This program is free software; you may redistribute it under the terms of the GNU General Public License version 3 or (at your option) any later version. This program has absolutely no warranty. Executing: ar -V stdout: GNU ar (GNU Binutils) 2.29.1.20171006 Copyright (C) 2017 Free Software Foundation, Inc. This program is free software; you may redistribute it under the terms of the GNU General Public License version 3 or (at your option) any later version. This program has absolutely no warranty. Defined make macro "FAST_AR_FLAGS" to "Scq" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int foo(int a) { return a+1; } Checking for program /usr/bin/ar...found Defined make macro "AR" to "/usr/bin/ar" Checking for program /usr/bin/ranlib...found Defined make macro "RANLIB" to "/usr/bin/ranlib" Executing: /usr/bin/ar cr /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconf1.a /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conf1.o Executing: /usr/bin/ranlib /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconf1.a Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" extern int foo(int); int main() { int b = foo(1); if (b); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -L/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -lconf1 stdout: ipo: error #11018: Cannot open libconf1.lib LINK : fatal error LNK1181: cannot open input file 'libconf1.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libconf1.lib LINK : fatal error LNK1181: cannot open input file 'libconf1.lib'Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" extern int foo(int); int main() { int b = foo(1); if (b); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -L/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -lconf1 Defined make macro "AR_FLAGS" to "cr" Defined make macro "AR_LIB_SUFFIX" to "lib" Popping language C ================================================================================ TEST checkSharedLinker from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1319) TESTING: checkSharedLinker from config.setCompilers(config/BuildSystem/config/setCompilers.py:1319) Check that the linker can produce shared libraries Executing: uname -s stdout: CYGWIN_NT-6.1 Checking shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe...found Defined make macro "LD_SHARED" to "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" Trying C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Added C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -shared -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10006: ignoring unknown option '/shared' Rejecting C linker flag -shared due to icl: command line warning #10006: ignoring unknown option '/shared' Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int (*fprintf_ptr)(FILE*,const char*,...) = fprintf; void foo(void){ fprintf_ptr(stdout,"hello"); return; } void bar(void){foo();} Pushing language C Popping language C Pushing language CUDA Popping language CUDA Pushing language Cxx Popping language Cxx Pushing language FC Popping language FC Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconftest.so -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: LINK : fatal error LNK1561: entry point must be defined Possible ERROR while running linker: exit code 6400 stdout: LINK : fatal error LNK1561: entry point must be defined Rejected C compiler flag because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl --help stdout: Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Usage: win32fe -- - must be the first argument to win32fe : {cl,icl,df,f90,ifl,bcc32,lib,tlib} cl: Microsoft 32-bit C/C++ Optimizing Compiler icl: Intel C/C++ Optimizing Compiler df: Compaq Visual Fortran Optimizing Compiler f90: Compaq Visual Fortran90 Optimizing Compiler ifl: Intel Fortran Optimizing Compiler ifort: Intel Fortran Optimizing Compiler nvcc: NVIDIA CUDA Compiler Driver bcc32: Borland C++ for Win32 lib: Microsoft Library Manager tlib: Borland Library Manager : --help: Output this help message and help for --path : specifies an addition to the PATH that is required (ex. the location of a required .dll) --use : specifies the variant of to use --verbose: Echo to stdout the translated commandline and other diagnostic information --version: Output version info for win32fe and --wait_for_debugger: Inserts an infinite wait after creation of and outputs PID so one can manually attach a debugger to the current process. In the debugger, one must set: tool::waitfordebugger = 0 to continue the execution normally. --win-l: For compilers, define -lfoo to link foo.lib instead of libfoo.lib --woff: Suppress win32fe specific warning messages ================================================================================= For compilers: win32fe will map the following to their native options: -c: Compile Only, generates an object file with .o extension This will invoke the compiler once for each file listed. -l: Link the file lib.lib or if using --win-l also, .lib -o : Output= context dependent -D: Define -I: Add to the include path -L: Add to the link path -g: Generate debug symbols in objects when specified for compilation, and in executables when specified for linking (some compilers specification at both times for full debugging support). -O: Enable compiletime and/or linktime optimizations. Ex: win32fe cl -g -c foo.c --verbose -Iinclude Note: win32fe will automatically find the system library paths and system include paths, relieving the user of the need to invoke a particular shell. ========================================================================= icl specific help: win32fe uses -nologo by default for nonverbose output. Use the flag: -logo to disable this feature. -g is identical to -Z7. -O is identical to -O2. ========================================================================= Intel(R) C++ Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 Copyright (C) 1985-2018 Intel Corporation. All rights reserved. Intel(R) C++ Compiler Help ========================== Intel(R) Compiler includes compiler options that optimize for instruction sets that are available in both Intel(R) and non-Intel microprocessors, but may perform additional optimizations for Intel microprocessors than for non-Intel microprocessors. In addition, certain compiler options for Intel(R) Compiler are reserved for Intel microprocessors. For a detailed description of these compiler options, including the instructions they implicate, please refer to "Intel(R) Compiler User and Reference Guides > Compiler Options." usage: icl [options] file1 [file2 ...] [/link linker_options] where options represents zero or more compiler options fileN is a C/C++ source (.c .cc .cpp .cxx .i), assembly (.asm), object (.obj), static library (.lib), or other linkable file linker_options represents zero or more linker options Notes ----- 1. Most Microsoft* Visual C++* compiler options are supported; a warning is printed for most unsupported options. The precise behavior of performance options does not always match that of the Microsoft Visual C++ compiler. 2. Intel C++ compiler options may be placed in your icl.cfg file. 3. Most options beginning with /Q are specific to the Intel C++ compiler: (*I) indicates other options specific to the Intel C++ compiler (*M) indicates /Q options supported by the Microsoft Visual C++ compiler Some options listed are only available on a specific system i32 indicates the feature is available on systems based on IA-32 architecture i64em indicates the feature is available on systems using Intel(R) 64 architecture Compiler Option List -------------------- Optimization ------------ /O1 optimize for maximum speed, but disable some optimizations which increase code size for a small speed benefit /O2 optimize for maximum speed (DEFAULT) /O3 optimize for maximum speed and enable more aggressive optimizations that may not improve performance on some programs /Ox enable maximum optimizations (same as /O2) /Os enable speed optimizations, but disable some optimizations which increase code size for small speed benefit (overrides /Ot) /Ot enable speed optimizations (overrides /Os) /Od disable optimizations /Oi[-] enable/disable inline expansion of intrinsic functions /Oy[-] enable/disable using EBP as a general purpose register (no frame pointer) (i32 only) /fast enable /QxHOST /O3 /Qipo /Qprec-div- /fp:fast=2 /Oa[-] assume no aliasing in program /Ow[-] assume no aliasing within functions, but assume aliasing across calls /Qno-builtin- disable the intrinsic /Qprotect-parens[-] enable/disable(DEFAULT) a reassociation optimization for REAL and COMPLEX expression evaluations by not honoring parenthesis Code Generation --------------- /Qx generate specialized code to run exclusively on processors indicated by as described below SSE2 May generate Intel(R) SSE2 and SSE instructions for Intel processors. Optimizes for the Intel NetBurst(R) microarchitecture. SSE3 May generate Intel(R) SSE3, SSE2, and SSE instructions for Intel processors. Optimizes for the enhanced Pentium(R) M processor microarchitecture and Intel NetBurst(R) microarchitecture. SSSE3 May generate Intel(R) SSSE3, SSE3, SSE2, and SSE instructions for Intel processors. Optimizes for the Intel(R) Core(TM) microarchitecture. SSE4.1 May generate Intel(R) SSE4 Vectorizing Compiler and Media Accelerator instructions for Intel processors. May generate Intel(R) SSSE3, SSE3, SSE2, and SSE instructions and it may optimize for Intel(R) 45nm Hi-k next generation Intel Core(TM) microarchitecture. SSE4.2 May generate Intel(R) SSE4 Efficient Accelerated String and Text Processing instructions supported by Intel(R) Core(TM) i7 processors. May generate Intel(R) SSE4 Vectorizing Compiler and Media Accelerator, Intel(R) SSSE3, SSE3, SSE2, and SSE instructions and it may optimize for the Intel(R) Core(TM) processor family. AVX May generate Intel(R) Advanced Vector Extensions (Intel(R) AVX), Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. CORE-AVX2 May generate Intel(R) Advanced Vector Extensions 2 (Intel(R) AVX2), Intel(R) AVX, SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. CORE-AVX-I May generate Intel(R) Advanced Vector Extensions (Intel(R) AVX), including instructions in Intel(R) Core 2(TM) processors in process technology smaller than 32nm, Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. ATOM_SSE4.2 May generate MOVBE instructions for Intel(R) processors, depending on the setting of option /Qinstruction. May also generate Intel(R) SSE4.2, SSE3, SSE2, and SSE instructions for Intel processors. Optimizes for Intel(R) Atom(TM) processors that support Intel(R) SSE4.2 and MOVBE instructions. ATOM_SSSE3 May generate MOVBE instructions for Intel(R) processors, depending on the setting of option /Qinstruction. May also generate Intel(R) SSSE3, SSE3, SSE2, and SSE instructions for Intel processors. Optimizes for the Intel(R) Atom(TM) processor that support Intel(R) SSE and MOVBE instructions. MIC-AVX512 May generate Intel(R) Advanced Vector Extensions 512 (Intel(R) AVX-512) Foundation instructions, Intel(R) AVX-512 Conflict Detection instructions, Intel(R) AVX-512 Exponential and Reciprocal instructions, Intel(R) AVX-512 Prefetch instructions for Intel(R) processors, and the instructions enabled with CORE-AVX2. Optimizes for Intel(R) processors that support Intel(R) AVX-512 instructions. KNM May generate Quad Fused Multiply Add (QFMA) and Quad Virtual Neural Network Instruction (QVNNI) and the instructions enabled with MIC-AVX512. Optimizes for Intel(R) Xeon Phi(TM) product family processor code named Knights Mill. CORE-AVX512 May generate Intel(R) Advanced Vector Extensions 512 (Intel(R) AVX-512) Foundation instructions, Intel(R) AVX-512 Conflict Detection instructions, Intel(R) AVX-512 Doubleword and Quadword instructions, Intel(R) AVX-512 Byte and Word instructions and Intel(R) AVX-512 Vector Length Extensions for Intel(R) processors, and the instructions enabled with CORE-AVX2. Optimizes for Intel(R) processors that support Intel(R) AVX-512 instructions. COMMON-AVX512 May generate Intel(R) Advanced Vector Extensions 512 (Intel(R) AVX-512) Foundation instructions, Intel(R) AVX-512 Conflict Detection instructions, as well as the instructions enabled with CORE-AVX2. Optimizes for Intel(R) processors that support Intel(R) AVX-512 instructions. BROADWELL CANNONLAKE HASWELL ICELAKE-CLIENT (or ICELAKE) ICELAKE-SERVER IVYBRIDGE KNL KNM SANDYBRIDGE SILVERMONT SKYLAKE SKYLAKE-AVX512 May generate instructions for processors that support the specified Intel(R) microarchitecture code name. Optimizes for Intel(R) processors that support the specified Intel(R) microarchitecture code name. Keywords KNL and SILVERMONT are only available on Windows* and Linux* systems. /QxHost generate instructions for the highest instruction set and processor available on the compilation host machine /Qax[,,...] generate code specialized for processors specified by while also generating generic IA-32 instructions. includes one or more of the following: SSE2 May generate Intel(R) SSE2 and SSE instructions for Intel processors. SSE3 May generate Intel(R) SSE3, SSE2, and SSE instructions for Intel processors. SSSE3 May generate Intel(R) SSSE3, SSE3, SSE2, and SSE instructions for Intel processors. SSE4.1 May generate Intel(R) SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel processors. SSE4.2 May generate Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel processors. AVX May generate Intel(R) Advanced Vector Extensions (Intel(R) AVX), Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. CORE-AVX2 May generate Intel(R) Advanced Vector Extensions 2 (Intel(R) AVX2), Intel(R) AVX, SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. CORE-AVX-I May generate Intel(R) Advanced Vector Extensions (Intel(R) AVX), including instructions in Intel(R) Core 2(TM) processors in process technology smaller than 32nm, Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. CORE-AVX512 May generate Intel(R) Advanced Vector Extensions 512 (Intel(R) AVX-512) Foundation instructions, Intel(R) AVX-512 Conflict Detection instructions, Intel(R) AVX-512 Doubleword and Quadword instructions, Intel(R) AVX-512 Byte and Word instructions and Intel(R) AVX-512 Vector Length Extensions for Intel(R) processors, and the instructions enabled with CORE-AVX2. BROADWELL CANNONLAKE HASWELL ICELAKE-CLIENT (or ICELAKE) ICELAKE-SERVER IVYBRIDGE KNL KNM SANDYBRIDGE SILVERMONT SKYLAKE SKYLAKE-AVX512 May generate instructions for processors that support the specified Intel(R) microarchitecture code name. Optimizes for Intel(R) processors that support the specified Intel(R) microarchitecture code name. Keywords KNL and SILVERMONT are only available on Windows* and Linux* systems. MIC-AVX512 May generate Intel(R) Advanced Vector Extensions 512 (Intel(R) AVX-512) Foundation instructions, Intel(R) AVX-512 Conflict Detection instructions, Intel(R) AVX-512 Exponential and Reciprocal instructions, Intel(R) AVX-512 Prefetch instructions for Intel(R) processors, and the instructions enabled with CORE-AVX2. /arch: generate specialized code to optimize for processors indicated by as described below BROADWELL CANNONLAKE HASWELL ICELAKE-CLIENT (or ICELAKE) ICELAKE-SERVER IVYBRIDGE KNL KNM SANDYBRIDGE SILVERMONT SKYLAKE-AVX512 SKYLAKE May generate instructions for processors that support the specified Intel(R) microarchitecture code name CORE-AVX2 May generate Intel(R) Advanced Vector Extensions 2 (Intel(R) AVX2), Intel(R) AVX, SSE4.2, SSE4.1, SSE3, SSE2, SSE, and SSSE3 instructions CORE-AVX-I May generate Float-16 conversion instructions and the RDRND instruction, Intel(R) Advanced Vector Extensions (Intel(R) AVX), Intel(R) SSE4.2, SSE4.1, SSE3, SSE2, SSE, and SSSE3 instructions AVX May generate Intel(R) AVX, SSE4.2, SSE4.1, SSSE3, SSE3, SSE2 and SSE instructions SSE4.2 May generate Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2 and SSE instructions SSE4.1 May generate Intel(R) SSE4.1, SSSE3, SSE3, SSE2 and SSE instructions SSSE3 May generate Intel(R) SSSE3, SSE3, SSE2 and SSE instructions SSE3 May generate Intel(R) SSE3, SSE2 and SSE instructions SSE2 May generate Intel(R) SSE2 and SSE instructions /Qinstruction: Refine instruction set output for the selected target processor [no]movbe - Do/do not generate MOVBE instructions with ATOM_SSSE3 (requires /QxATOM_SSSE3) /GR[-] enable/disable C++ RTTI /Qcxx-features enable standard C++ features (/GX /GR) /EHa enable asynchronous C++ exception handling model /EHs enable synchronous C++ exception handling model /EHc assume extern "C" functions do not throw exceptions /Qsafeseh[-] Registers exceptions for safe exception handling (DEFAULT) /Qregcall make __regcall the default calling convention /Gv make __vectorcall the default calling convention /guard:cf enable control flow protection mechanism /hotpatch[:n] generate padding bytes for function entries to enable image hotpatching. If specified, use 'n' as the padding. /Qextend-arguments:[32|64] By default, unprototyped scalar integer arguments are passed in 32-bits (sign-extended if necessary). On Intel(R) 64, unprototyped scalar integer arguments may be extended to 64-bits. /Qgpu-arch:[,] build offload code for graphics to run on a particular graphics processor haswell - May generate instructions for the graphics processor that is on Intel(R) microarchitecture code name Haswell broadwell - May generate instructions for the graphics processor that is on Intel(R) microarchitecture code name Broadwell cherryview - May generate instructions for the graphics processor that is on Intel(R) microarchitecture code name Cherryview skylake - May generate instructions for the graphics processor that is on Intel(R) microarchitecture code name Skylake broxton - May generate instructions for the graphics processor that is on Intel(R) microarchitecture code name Broxton /Qgpu-asm-dump[:] generate a native assembly listing for the processor graphics code to be offloaded (Intel(R) Graphics Technology only) /Qm32 generate code for IA-32 architecture /Qm64 generate code for Intel(R) 64 architecture /Qstringop-strategy: Override the internal decision heuristic for the particular algorithm to use for inlining string operations. The allowed values for : rep - Expand using 1 "rep" prefix (DEFAULT for /Os) const_size_loop - Expand into an inline loop when size is known at compile time (DEFAULT) libcall - Always use a library call. /Qstringop-inline-threshold: inline calls to memcall-like (memcpy, memset) functions when the number of bytes the functions handle are known at compile time and less than /Qcf-protection[:] Enables Control-flow Enforcement Technology (CET) protection, which defends your program from certain attacks that exploit vulnerabilities. shadow_stack - Enables shadow stack protection branch_tracking - Enables endbranch (EB) generation full - Enables both shadow stack protection and endbranch (EB) generation (same as no ) none - Disables Control-flow Enforcement Technology protection Interprocedural Optimization (IPO) ---------------------------------- /Qip[-] enable(DEFAULT)/disable single-file IP optimization within files /Qipo[n] enable multi-file IP optimization between files /Qipo-c generate a multi-file object file (ipo_out.obj) /Qipo-S generate a multi-file assembly file (ipo_out.asm) /Qip-no-inlining disable full and partial inlining /Qip-no-pinlining disable partial inlining /Qipo-separate create one object file for every source file (overrides /Qipo[n]) /Qipo-jobs specify the number of jobs to be executed simultaneously during the IPO link phase Advanced Optimizations ---------------------- /Qunroll[n] set maximum number of times to unroll loops. Omit n to use default heuristics. Use n=0 to disable the loop unroller /Qunroll-aggressive[-] enables more aggressive unrolling heuristics /Qscalar-rep[-] enable(DEFAULT)/disable scalar replacement (requires /O3) /Qansi-alias[-] enable(DEFAULT)/disable use of ANSI aliasing rules optimizations; user asserts that the program adheres to these rules /Qansi-alias-check[-] enable(DEFAULT)/disable ANSI alias checking when using /Qansi-alias /Qcomplex-limited-range[-] enable/disable(DEFAULT) the use of the basic algebraic expansions of some complex arithmetic operations. This can allow for some performance improvement in programs which use a lot of complex arithmetic at the loss of some exponent range. /Qalias-const[-] enable/disable(DEFAULT) a heuristic stating that if two arguments to a function have pointer type, a pointer to const does not alias a pointer to non-const. Also known as the input/output buffer rule, it assumes that input and output buffer arguments do not overlap. /Qalias-args[-] enable(DEFAULT)/disable C/C++ rule that function arguments may be aliased; when disabling the rule, the user asserts that this is safe /Qopt-multi-version-aggressive[-] enables more aggressive multi-versioning to check for pointer aliasing and scalar replacement /Qopt-ra-region-strategy[:] select the method that the register allocator uses to partition each routine into regions routine - one region per routine block - one region per block trace - one region per trace loop - one region per loop default - compiler selects best option /Qvec[-] enables(DEFAULT)/disables vectorization /Qvec-guard-write[-] enables cache/bandwidth optimization for stores under conditionals within vector loops /Qvec-threshold[n] sets a threshold for the vectorization of loops based on the probability of profitable execution of the vectorized loop in parallel /Qvecabi: select vector function ABI legacy - use the legacy vector function ABI compat - use the compatibility vector function ABI (DEFAULT) cmdtarget - generate an extended set of vector functions /Qopt-malloc-options:{0|1|2|3|4} specify malloc configuration parameters. Specifying a non-zero value will cause alternate configuration parameters to be set for how malloc allocates and frees memory /Qopt-jump-tables: control the generation of jump tables default - let the compiler decide when a jump table, a series of if-then-else constructs or a combination is generated large - generate jump tables up to a certain pre-defined size (64K entries) - generate jump tables up to in size use /Qopt-jump-tables- to lower switch statements as chains of if-then-else constructs /Qopt-block-factor: specify blocking factor for loop blocking /Qfreestanding compile in a freestanding environment where the standard library may not be present /Qopt-streaming-stores: specifies whether streaming stores are generated always - enables generation of streaming stores under the assumption that the application is memory bound. Also, the user is responsible for inserting the right memory fences for synchronization auto - compiler decides when streaming stores are used (DEFAULT) never - disables generation of streaming stores /Qipp[:] link some or all of the Intel(R) Integrated Performance Primitives (Intel(R) IPP) libraries and bring in the associated headers common - link using the main libraries set. This is the default value when /Qipp is specified crypto - link using the main libraries set and the crypto library /Qipp-link: choose whether to link with static or dynamic libraries to support Intel(R) Integrated Performance Primitives (Intel(R) IPP) dynamic - link using the dynamic libraries set. This is the default value when /Qipp is specified on Windows static - link using the static libraries set. This is the default value when /Qipp is specified on Linux /Qmkl[:] link to the Intel(R) Math Kernel Library (Intel(R) MKL) and bring in the associated headers parallel - link using the threaded Intel(R) MKL libraries. This is the default when /Qmkl is specified sequential - link using the non-threaded Intel(R) MKL libraries cluster - link using the Intel(R) MKL Cluster libraries plus the sequential Intel(R) MKL libraries /Qtbb link to the Intel(R) Threading Building Blocks (Intel(R) TBB) libraries and bring in the associated headers /Qdaal[:] link to the Intel(R) Data Analytics Acceleration Library (Intel(R) DAAL) libraries and bring in the associated headers parallel - link using the threaded Intel(R) DAAL (DEFAULT) sequential - link using the non-threaded Intel(R) DAAL /Qopt-subscript-in-range[-] assumes no overflows in the intermediate computation of the subscripts /Quse-intel-optimized-headers[-] take advantage of the optimized header files /Qvla[-] enable/disable(DEFAULT) Variable Length Arrays (C99 feature) /Qintel-extensions[-] enable(DEFAULT)/disable C/C++ language extensions such as array notation, Intel(R) Cilk(TM) Plus language extensions, and support for decimal floating-point types. /Qopt-matmul[-] replace matrix multiplication with calls to intrinsics and threading libraries for improved performance (DEFAULT at /O3 /Qparallel) /Qsimd[-] enables(DEFAULT)/disables vectorization using simd pragma /Qsimd-function-pointers[-] enables/disables(DEFAULT) pointers to simd-enabled functions /Qguide-opts: tells the compiler to analyze certain code and generate recommendations that may improve optimizations /Qguide-file[:] causes the results of guide to be output to a file /Qguide-file-append[:] causes the results of guide to be appended to a file /Qguide[:] lets you set a level (1 - 4) of guidance for auto-vectorization, auto-parallelization, and data transformation (DEFAULT is 4 when the option is specified) /Qguide-data-trans[:] lets you set a level (1 - 4) of guidance for data transformation (DEFAULT is 4 when the option is specified) /Qguide-par[:] lets you set a level (1 - 4) of guidance for auto-parallelization (DEFAULT is 4 when the option is specified) /Qguide-par[:] lets you set a level (1 - 3) of guidance for auto-parallelization (DEFAULT is 2 when the option is specified) /Qguide-vec[:] lets you set a level (1 - 4) of guidance for auto-vectorization (DEFAULT is 4 when the option is specified) /Qguide-profile:<[file|dir]>[,[file|dir],...] specify a loop profiler data file (or set of files in a directory) when using the /Qguide option /Qopt-mem-layout-trans[:] controls the level of memory layout transformations performed by the compiler 0 - disable memory layout transformations (same as /Qopt-mem-layout-trans-) 1 - enable basic memory layout transformations 2 - enable more memory layout transformations (DEFAULT when the option is specified) 3 - enable aggressive memory layout transformations /Qopt-prefetch[:n] enable levels of prefetch insertion, where 0 disables. n may be 0 through 5 inclusive. Default is 2. /Qopt-prefetch- disable(DEFAULT) prefetch insertion. Equivalent to /Qopt-prefetch:0 /Qopt-prefetch-distance:n1[,n2] specify the prefetch distance (how many iterations ahead, use n1 and n2 values such that n1>=n2) to be used for compiler generated prefetches inside loops. n1 indicates distance from memory to L2 cache and n2 indicates distance from L2 to L1. /Qopt-prefetch-issue-excl-hint generates PrefetchW instruction for Intel(R) microarchitecture code name Broadwell processors and beyond when /Qopt-prefetch is also used /Qopt-gather-scatter-unroll:n specify an alternative loop unroll sequence for gather and scatter loops (Intel(R) MIC Architecture specific). Disable with /Qopt-gather-scatter-unroll- (equivalent to n=0) /Qopt-dynamic-align enable(DEFAULT) dynamic data alignment optimizations. Specify /Qopt-dynamic-align- to disable /Qalign-loops[:n] specify code alignment of loops to improve performance. n is the number of bytes for the minimum alignment boundary. It must be a power of 2 between 1 and 4096. If n is not present, an alignment of 16 bytes is used. Use of /Qalign-loops- (DEFAULT) sets alignment to 1. /Qopt-zmm-usage: Specifies the level of zmm registers usage. You can specify one of the following: low - Tells the compiler that the compiled program is unlikely to benefit from zmm registers usage. It specifies that the compiler should avoid using zmm registers unless it can prove the gain from their usage. high - Tells the compiler to generate zmm code without restrictions /Qoverride-limits provides a way to override certain internal compiler limits that are intended to prevent excessive memory usage or compile times for very large, complex compilation units. Profile Guided Optimization (PGO) --------------------------------- /Qprof-dir specify directory for profiling output files (*.dyn and *.dpi) /Qprof-src-root specify project root directory for application source files to enable relative path resolution during profile feedback on sources below that directory /Qprof-src-root-cwd specify the current directory as the project root directory for application source files to enable relative path resolution during profile feedback on sources below that directory /Qprof-src-dir[-] specify whether directory names of sources should be considered when looking up profile records within the .dpi file /Qprof-file specify file name for profiling summary file /Qprof-data-order[-] enable/disable(DEFAULT) static data ordering with profiling /Qprof-func-order[-] enable/disable(DEFAULT) function ordering with profiling /Qprof-gen[:keyword[,keyword]] instrument program for profiling. Optional keywords are as follows. default - Produces an instrumented object file. This is the same as specifying the /Qprof-gen option with no keyword. srcpos - Produces an instrumented object file and information needed for using the code coverage tool. globdata - Produces an instrumented object file that includes information for global data layout. threadsafe - Collects PGO data with guards for threaded applications. /Qprof-gen- disable profiling instrumentation /Qprof-use[:] enable use of profiling information during optimization weighted - invokes profmerge with -weighted option to scale data based on run durations [no]merge - enable(default)/disable the invocation of the profmerge tool /Qprof-use- disable use of profiling information during optimization /Qcov-gen instrument program for profiling. Use /Qcov-gen- to disable /Qcov-dir specify directory for profiling output files (*.dyn and *.dpi) /Qcov-file specify file name for profiling summary file /Qfnsplit[:] enable function splitting (enabled with /Qprof-use for IA-32 Windows) n - positive integer indicating the threshold number. The blocks can be placed into a different code segment if their execution probability is less than the specified value of range 0 <= n <= 100 use /Qfnsplit- to disable /Qinstrument-functions[-] determine whether function entry and exit points are instrumented /Qprof-hotness-threshold: set the hotness threshold for function grouping and function ordering val indicates percentage of functions to be placed in hot region. This option requires /Qprof-use and /Qprof-func-order /Qprof-value-profiling:[,,...] limit value profiling none - inhibit all types of value profiling nodivide - inhibit value profiling of non-compile time constants used in division or remainder operations noindcall - inhibit value profiling of function addresses at indirect call sites /Qprofile-functions enable instrumentation in generated code for collecting function execution time profiles /Qprofile-loops: enable instrumentation in generated code for collecting loop execution time profiles inner - instrument inner loops outer - instrument outer loops all - instrument all loops /Qprofile-loops-report: Control the level of instrumentation inserted for reporting loop execution profiles 1 - report loop times 2 - report loop times and iteration counts Optimization Reports -------------------- /Qopt-report[:n] generate an optimization report. Default destination is .optrpt. Levels of 0 - 5 are valid. Please see documentation for additional details of information provided by phase per level. 0 disable optimization report output 2 DEFAULT when enabled /Qopt-report-file:[stdout | stderr | ] specify the filename or output stream for the generated report /Qopt-report-stdout specify the generated report should be directed to stdout /Qopt-report-per-object specify the generated report should be directed to a .optrpt file in the output directory (DEFAULT when another destination for the report is not specified) /Qopt-report-phase:[,,...] specify one or more phases that reports are generated against /Qopt-report-routine:[,,...] restrict the report to routines containing the given name /Qopt-report-filter: restricts the opt-report to specific files, routines or line number ranges. Refer to the documentation for the specific syntax of parameter string. /Qopt-report-format:[text|vs] specify the output format to be used for the opt-report as either plain text or a format for use in the Microsoft* Visual Studio IDE /Qopt-report-embed[-] When enabled, if an assembly file is being generated, special loop info annotations will be emitted in the assembly file. If an object file/executable is being generated, these will be emitted into the object file/executable for use by the Intel VTune Amplifier application. Automatically enabled when symbolic debug information is enabled. /Qopt-report-help display the optimization phases available for reporting /Qopt-report-names: Specifies whether mangled or unmangled names should appear in the optimization report. mangled - use mangled names unmangled - use unmangled names (DEFAULT) /Qopt-report-annotate[:] Annotate source files with optimization reports in specified format html - annotate in HTML format text - annotate in text format (DEFAULT) /Qopt-report-annotate-position: Specify the site where loop related optimization reports appear in the annotated source for inlined routines caller - annotate at caller site callee - annotate at callee site both - annotate at both caller and callee site /Qtcheck[:mode] enable analysis of threaded applications (requires Intel(R) Thread Checker; cannot be used with compiler alone) tci - instruments a program to perform a thread-count-independent analysis tcd - instruments a program to perform a thread-count-dependent analysis (DEFAULT when mode is not used) api - instruments a program at the api-imports level /Qtcollect[:] inserts instrumentation probes calling the Intel(R) Trace Collector API. The library .lib is linked in the default being VT.lib (requires Intel(R) Trace Collector) /Qtcollect-filter:file Enable or disable the instrumentation of specified functions. (requires Intel(R) Trace Collector) OpenMP* and Parallel Processing ------------------------------ /Qopenmp enable the compiler to generate multi-threaded code based on the OpenMP* directives (same as /openmp) Use /Qopenmp- to disable /Qopenmp-stubs enables the user to compile OpenMP programs in sequential mode. The OpenMP directives are ignored and a stub OpenMP library is linked (sequential) /Qopenmp-lib: choose which OpenMP library version to link with compat - use the Microsoft compatible OpenMP run-time libraries (DEFAULT) /Qopenmp-threadprivate: choose which threadprivate implementation to use compat - use the Microsoft compatible thread local storage legacy - use the Intel compatible implementation (DEFAULT) /Qparallel enable the auto-parallelizer to generate multi-threaded code for loops that can be safely executed in parallel /Qpar-threshold[n] set threshold for the auto-parallelization of loops where n is an integer from 0 to 100 /Qpar-runtime-control[n] Control parallelizer to generate runtime check code for effective automatic parallelization. n=0 no runtime check based auto-parallelization n=1 generate runtime check code under conservative mode (DEFAULT when enabled) n=2 generate runtime check code under heuristic mode n=3 generate runtime check code under aggressive mode /Qpar-schedule-static[:n] Specifies a scheduling algorithm for DO loop iteration. Divides iterations into contiguous pieces. Size n if specified, equal sized pieces if not. /Qpar-schedule-static-balanced[:n] Divides iterations into even-sized chunks. Size n if specified, equal sized pieces if not. /Qpar-schedule-static-steal[:n] Divides iterations into even-sized chunks, but allows threads to steal parts of chunks from neighboring threads /Qpar-schedule-dynamic[:n] Specifies a scheduling algorithm for DO loop iteration. Assigns iterations to threads in chunks dynamically. Chunk size is n iterations if specified, otherwise 1. /Qpar-schedule-guided[:n] Specifies a scheduling algorithm for DO loop iteration. Indicates a minimum number of iterations. If specified, n is the minimum number, otherwise 1. /Qpar-schedule-guided-analytical[:n] Divides iterations by using exponential distribution or dynamic distributions. /Qpar-schedule-runtime Specifies a scheduling algorithm for DO loop iteration. Defers the scheduling decision until runtime. /Qpar-schedule-auto Lets the compiler or run-time system determine the scheduling algorithm. /Qpar-adjust-stack perform fiber-based main thread stack adjustment /Qpar-affinity=[,...][,][,] tune application performance by setting different thread affinity /Qpar-num-threads= tune application performance by setting different number of threads /Qparallel-source-info[:n] enable(DEFAULT)/disable the emission of source location information for parallel code generation with OpenMP and auto-parallelization 0 - disable (same as /Qparallel-source-info-) 1 - emit routine name and line information (DEFAULT) 2 - emit path, file, routine name and line information /Qpar same as /Qparallel /Qopenmp-simd Enables OpenMP* SIMD compilation. Enabled by default with /Qopenmp. Use /Qopenmp-simd- to disable. /Qopenmp-offload[:] Enables OpenMP* offloading compilation for target pragmas. This option only applies to Intel(R) MIC Architecture and Intel(R) Graphics Technology. Enabled by default with /Qopenmp. Use /Qopenmp-offload- to disable. Specify kind to specify the default device for target pragmas host - allow target code to run on host system while still doing the outlining for offload mic - specify Intel(R) MIC Architecture gfx - specify Intel(R) Graphics Technology Floating Point -------------- /fp: enable floating point model variation except[-] - enable/disable floating point exception semantics fast[=1|2] - enables more aggressive floating point optimizations precise - allows value-safe optimizations source - enables intermediates in source precision sets /assume:protect_parens for Fortran strict - enables /fp:precise /fp:except, disables contractions and enables pragma stdc fenv_access consistent - enables consistent, reproducible results for different optimization levels or between different processors of the same architecture double - rounds intermediates in 53-bit (double) precision extended - rounds intermediates in 64-bit (extended) precision /Qfp-speculation: enable floating point speculations with the following conditions: fast - speculate floating point operations (DEFAULT) safe - speculate only when safe strict - same as off off - disables speculation of floating-point operations /Qpc32 set internal FPU precision to 24 bit significand /Qprec improve floating-point precision /Qprec-sqrt[-] determine if certain square root optimizations are enabled /Qprec-div[-] improve precision of FP divides (some speed impact) /Qfast-transcendentals[-] generate a faster version of the transcendental functions /Qfp-port[-] round fp results at assignments and casts (some speed impact) /Qfp-stack-check enable fp stack checking after every function/procedure call /Qrcd rounding mode to enable fast float-to-int conversions /Qftz[-] enable/disable flush denormal results to zero /Qfma[-] enable/disable the combining of floating point multiplies and add/subtract operations /Qfp-trap:[,,...] control floating point traps at program start. can be of the following values [no]divzero - [Do not] trap on division by zero [no]inexact - [Do not] trap on inexact result [no]invalid - [Do not] trap on invalid operation [no]overflow - [Do not] trap on overflow [no]underflow - [Do not] trap on underflow [no]denormal - [Do not] trap on denormal all - enable trap on all of the above none - trap on none of the above common - trap on most commonly used IEEE traps (invalid, division by zero, overflow) /Qfp-trap-all:[,,...] control floating point traps in every routine. can be of the values specified in /Qfp-trap /Qimf-absolute-error:value[:funclist] define the maximum allowable absolute error for math library function results value - a positive, floating-point number conforming to the format [digits][.digits][{e|E}[sign]digits] funclist - optional comma separated list of one or more math library functions to which the attribute should be applied /Qimf-accuracy-bits:bits[:funclist] define the relative error, measured by the number of correct bits, for math library function results bits - a positive, floating-point number funclist - optional comma separated list of one or more math library functions to which the attribute should be applied /Qimf-arch-consistency:value[:funclist] ensures that the math library functions produce consistent results across different implementations of the same architecture value - true or false funclist - optional comma separated list of one or more math library functions to which the attribute should be applied /Qimf-max-error:ulps[:funclist] defines the maximum allowable relative error, measured in ulps, for math library function results ulps - a positive, floating-point number conforming to the format [digits][.digits][{e|E}[sign]digits] funclist - optional comma separated list of one or more math library functions to which the attribute should be applied /Qimf-precision:value[:funclist] defines the accuracy (precision) for math library functions value - defined as one of the following values high - equivalent to max-error = 0.6 medium - equivalent to max-error = 4 (DEFAULT) low - equivalent to accuracy-bits = 11 (single precision); accuracy-bits = 26 (double precision) funclist - optional comma separated list of one or more math library functions to which the attribute should be applied /Qimf-domain-exclusion:classlist[:funclist] indicates the input arguments domain on which math functions must provide correct results. classlist - defined as one of the following values: nans, infinities, denormals, zeros all, none, common funclist - optional list of one or more math library functions to which the attribute should be applied. /Qimf-force-dynamic-target[:funclist] Instructs the compiler to use run-time dispatch in calls to math functions funclist - optional list of one or more math library functions to which the attribute should be applied. /Qfinite-math-only Allow optimizations for floating point arithmetic that assume arguments and results are not NaNs or Infinities Inlining -------- /Ob control inline expansion: n=0 disable inlining n=1 inline functions declared with __inline, and perform C++ inlining n=2 inline any function, at the compiler's discretion /Qinline-min-size: set size limit for inlining small routines /Qinline-min-size- no size limit for inlining small routines /Qinline-max-size: set size limit for inlining large routines /Qinline-max-size- no size limit for inlining large routines /Qinline-max-total-size: maximum increase in size for inline function expansion /Qinline-max-total-size- no size limit for inline function expansion /Qinline-max-per-routine: maximum number of inline instances in any function /Qinline-max-per-routine- no maximum number of inline instances in any function /Qinline-max-per-compile: maximum number of inline instances in the current compilation /Qinline-max-per-compile- no maximum number of inline instances in the current compilation /Qinline-factor: set inlining upper limits by n percentage /Qinline-factor- do not set set inlining upper limits /Qinline-forceinline treat inline routines as forceinline /Qinline-dllimport allow(DEFAULT)/disallow functions declared __declspec(dllimport) to be inlined /Qinline-calloc directs the compiler to inline calloc() calls as malloc()/memset() /Qinline-min-caller-growth: set lower limit on caller growth due to inlining a single routine /Qinline-min-caller-growth- no lower limit on caller growth due to inlining a single routine Output, Debug, PCH ------------------ /c compile to object (.obj) only, do not link /S compile to assembly (.asm) only, do not link /FAs produce assembly file with optional source annotations /FAc produce assembly file with optional code annotations /FA produce assembly file /Fa[file] name assembly file (or directory for multiple files; i.e. /FaMYDIR\) /Fo[file] name object file (or directory for multiple files; i.e. /FoMYDIR\) /Fe[file] name executable file or directory /Fp[file] name precompiled header file /Fi[file] name preprocessed file (or directory for multiple files; i.e. /FiMYDIR\) /Zi, /ZI, /Z7 Produce symbolic debug information. The /Zi and /ZI flags emit the debug information for types into a separate PDB file. /Zo[-] When symbolic debug information is being produced, enable/disable emission of additional symbolic debug information to describe optimized code. /debug[:keyword] Control the emission of debug information. Valid [keyword] values: none Disables debug generation. all, full (default if no keyword was specified) Generates complete debug information. minimal Generates line number information. [no]inline-debug-info Controls additional debug information for inlined code. [no]expr-source-pos Controls output of source positions for expressions. /pdbfile[:filename] Specify that debug related type information should be generated to a program database file at link time. /nopdbfile Do not generate debug related information to a program database file. /Qtrapuv trap uninitialized variables /RTCu report use of variable that was not initialized /RTC1 equivalent to /RTCsu /RTCs enable stack frame runtime checks /RTCc enable checks for converting to smaller types /Qmap-opts enable option mapping tool /Yc[file] create precompiled header file /Yu[file] use precompiled header file /Y- ignore all other precompiled header file options /Qpchi[-] enable(DEFAULT)/disable PCH coexistence, to reduce build time /FD generate file dependencies /FR[file] name extended source browser file /Qcheck-pointers: Specifies what type of bounds checking occurs. Possible values are: none - Disables bounds checking. This is the default. rw - Checks bounds for reads and writes through pointers. write - Checks bounds for writes through pointers only. /Qcheck-pointers-mpx: Enables bounds checking using Intel(R) MPX support. Possible values are: none - Disables bounds checking. This is the default. rw - Checks bounds for reads and writes through pointers. write - Checks bounds for writes through pointers only. This switch is only valid on targets with Intel(R) MPX support. /Qcheck-pointers-dangling: Specifies what type of dangling pointer checking occurs. Possible values are: none - Disables dangling pointer checking. This is the default. heap - Check dangling references on heap. stack - Check dangling references on stack. all - Check dangling references on both heap and stack. /Qcheck-pointers-undimensioned[-] Bounds checking occurs for memory access through arrays that are declared without dimensions. This checking occurs for both dimensioned and undimensioned arrays. /Qcheck-pointers-narrowing[-] When this is disabled, Pointer Checker will not give an error when pointers to a structure field are moved to fields in the same structure. /Qeliminate-unused-debug-types[-] When disabled, debug information for all types present in the sources will be emitted. Using this option may cause a large increase in the size of the debug information. /Qemit-build-options Output the options used during the compilation to a corresponding .dashboard file. This file is to be consumed by the dbmerge tool and used by the dashboard tool. /Qemit-messages Output the diagnostics emitted during the compilation to a corresponding .dashboard file. This file is to be consumed by the dbmerge tool and used by the dashboard tool. Preprocessor ------------ /QA[] create an assertion having value /C do not strip comments /D[{=|#}] define macro /U remove predefined macro /E preprocess to stdout /EP preprocess to stdout, omitting #line directives /EP /P preprocess to file, omitting #line directives /P preprocess to file /u remove all predefined macros /FI force inclusion of file /I add directory to include file search path /X remove standard directories from include file search path /QH print include file order /QM generate makefile dependency information /QMM similar to /QM, but do not include system header files /QMG similar to /QM, but treat missing header files as generated files /QMD preprocess and compile, generating output file containing dependency information ending with extension .d /QMMD similar to /QMD, but do not include system header files /QMF generate makefile dependency information in file (must specify /QM or /QMM) /QMT change the default target rule for dependency generation /QdM output macro definitions in effect after preprocessing (use with /E) /QdD same as /QdM, but output #define directives in preprocessed source /QdN same as /QdD, but #define directives contain only macro names /Qicl- do not predefine the "__ICL" and "__INTEL_COMPILER" macros. Warning: can prevent correct Intel header compilation Component Control ----------------- /Qoption,, pass options to tool specified by /Qlocation,, set as the location of tool specified by Language -------- /Qstd= enable language support for , as described below c99 conforms to ISO/IEC 9899:1999 standard for C programs c11 conforms to ISO/IEC 9899:2011 standard for C programs c++11 enables C++11 support for C++ programs c++14 enables experimental C++14 support for C++ programs c++17 enables experimental C++17 support for C++ programs /Za disable Microsoft Visual C++ compiler language extensions /Zg enable the generation of function prototypes /Zp[n] specify alignment constraint for structures where n=1,2,4,8,16. 16 is the default /Zc:arg1[,arg2] specify standard conformance for the following arguments: forScope[-] enforce standard compliance in for loop scope throwingNew[-] link with the operator new implementation wchar_t[-] specify that wchar_t is a native data type auto[-] enforce compliance to the new standard meaning for auto trigraphs[-] accept trigraph character sequences strictStrings[-] enforce const qualification for string literals rvalueCast[-] cast of lvalue to its own type results in rvalue threadSafeInit[-] thread-safe initialization of local statics inline[-] control inline expansion /Zs perform syntax and semantic checking only (no object file produced) /vd{0|1|2} disable or enable hidden vtordisp field in C++ objects /vm[x] specify representation method for C++ pointers to members /J change default char type to unsigned /noBool suppresses the C++ bool, true, and false keywords /Qtemplate-depth:n control the depth in which recursive templates are expanded /Qrestrict[-] enable/disable the 'restrict' keyword for disambiguating pointers /Qhelp-pragma output supported pragmas and their usage syntax /check:[,,...] check run-time conditions. keywords: [no]conversions, [no]stack, [no]uninit Compiler Diagnostics -------------------- /w disable all warnings /W0 print only errors /W1, /W2, /W3 print only errors and warnings (DEFAULT) /W4, /Wall print errors, warnings and most remarks /W5 print all errors, warnings and remarks /WL print brief one-line diagnostics /WX force warnings to be reported as errors /Werror-all force warnings and currently enabled remarks to be reported as errors /Wcheck enable more strict diagnostics /Wport issue portability diagnostics /Qeffc++ enable effective C++ diagnostic warnings /Qwo[,,...] issue diagnostics L1 through LN only once /Wp64 print diagnostics for 64-bit porting /Qdiag-enable:[,,...] enable the specified diagnostics or diagnostic groups /Qdiag-disable:[,,...] disable the specified diagnostics or diagnostic groups where may be individual diagnostic numbers or group names. where group names include: thread - diagnostics to aid in thread-enabling source power - controls whether diagnostics are enabled for possibly inefficient code that may affect power consumption when running on Intel(R) processors port-linux - diagnostics for Microsoft extensions that may cause errors when porting to Linux/MacOS openmp - diagnostics issued by the OpenMP* parallelizer warn - diagnostics that have "warning" severity level error - diagnostics that have "error" severity level remark - diagnostics that are remarks or comments vec - diagnostics issued by the vectorizer par - diagnostics issued by the auto-parallelizer cpu-dispatch - specifies the CPU dispatch remarks /Qdiag-error:[,,...] output the specified diagnostics or diagnostic groups as errors /Qdiag-warning:[,,...] output the specified diagnostics or diagnostic groups as warnings /Qdiag-remark:[,,...] output the the specified diagnostics or diagnostic groups as remarks /Qdiag-dump display the currently enabled diagnostic messages to stdout or to a specified diagnostic output file. /Qdiag-file[:] where diagnostics are emitted to. Not specifying this causes messages to be output to stderr /Qdiag-file-append[:] where diagnostics are emitted to. When already exists, output is appended to the file /Qdiag-id-numbers[-] enable(DEFAULT)/disable the diagnostic specifiers to be output in numeric form /Qdiag-error-limit: specify the maximum number of errors emitted /Qdiag-once:[,,...] issue diagnostics v1 through vN only once /Wpch-messages[-] enable(DEFAULT)/disable PCH information messages Miscellaneous ------------- /nologo do not display compiler version information /Qsave-temps store the intermediate files in current directory and name them based on the source file. Only saves files that are generated by default /watch: tells the driver to output processing information keywords: all, none (same as /nowatch), [no]source, [no]cmd [no]mic-cmd /nowatch suppress processing information output (DEFAULT) /Tc compile file as C source /Tp compile file as C++ source /TC compile all source or unrecognized file types as C source files /TP compile all source or unrecognized file types as C++ source files /showIncludes emit include file names /Qmultibyte-chars[-] provide support for multi-byte characters /MP[] create multiple processes that can be used to compile large numbers of source files at the same time /MP-force Use with /MP to force the given processes to be created /bigobj generate objects with increased address capacity /Qoffload: define whether offload is enabled, and if enabled, whether CPU fallback is permitted keywords: none, optional, mandatory /Qoffload-attribute-target: flags every global routine and global data object in the source file with the offload attribute target() name - mic, gfx (gfx for C/C++ compilation only) /Qoffload-option,,,"option list" appends additional options for offload compilations given the target and tool. The option list is a space separated quoted list of options target - mic, gfx (gfx for C/C++ compilation only) tool - compiler, link, asm, jit (gfx only) /Qoffload- disable any offload usage /Qoffload-arch:[:] specify the target architecture to use when offloading code arch - Specifies the target architecture. On Intel(R) 64 architecture targeting Intel(R) MIC Architecture, arch can be mic-avx512. On IA-32 and Intel(R) 64 architectures targeting Intel(R) Graphics Technology, arch can be haswell, broadwell, cherryview, skylake, or broxton. visa - Specifies the virtual ISA (vISA) version to be used. This optional argument is only allowed on IA-32 and Intel(R) 64 architectures targeting Intel(R) Graphics Technology. You can specify either visa3.1 or visa3.2. /Qoffload-svm[-] Determines whether the compiler uses Shared Virtual Memory (SVM) mode. This option only applies to Intel(R) Graphics Technology. Data ---- /Zp[n] specify alignment constraint for structures (n=1,2,4,8,16 /Zp16 DEFAULT) /GS enable overflow security checks. Optional can specify: partial - provide a stack protection level that is compatible with Microsoft* Visual Studio 2008. strong - provide full stack security level checking. This setting is compatible with recent Microsoft* Visual Studio stack protection heuristics. This is the same as specifying /GS with no keyword. off - Same as /GS- (DEFAULT) /GF enable read-only string pooling optimization /GA optimize for Windows application (assume .exe) /GT enable fiber-safe thread local storage /Qauto-ilp32 specify that the application cannot exceed a 32-bit address space (/Qipo[n] required) /Qpatchable-addresses generate code such that references to statically assigned addresses can be patched with arbitrary 64-bit addresses. /Qsfalign8 may align stack for functions with 8 or 16 byte vars (DEFAULT) /Qsfalign16 may align stack for functions with 16 byte vars /Qsfalign force stack alignment for all functions /Qsfalign- disable stack alignment for all functions /homeparams force to store parameters passed in registers to the stack /Qglobal-hoist[-] enable(DEFAULT)/disable external globals are load safe /Qkeep-static-consts[-] enable/disable(DEFAULT) the ability to preserve allocation of variables that are not referenced in the source /Qlong-double enable 80-bit 'long double' /Qnobss-init disable placement of zero-initialized variables in BSS (use DATA) /Qzero-initialized-in-bss[-] put explicitly zero initialized variables into the DATA section instead of the BSS section /Qfnalign: align the start of functions on a 2 (DEFAULT) or byte boundary where is a power of 2 /Qfnalign align the start of functions to an optimal machine-dependent value. /Qfnalign- (DEFAULT) aligns on a 2-byte boundary Compatibility ------------- /Qms tells the compiler to emulate Microsoft compatibility bugs n=0 disable Microsoft compatibility bugs n=1 enable most Microsoft compatibilities (DEFAULT) n=2 full Microsoft compatibility /Qvc enable compatibility with a specific Microsoft* Visual Studio version 12 - Microsoft* Visual Studio 2013 compatibility 14 - Microsoft* Visual Studio 2015 compatibility 14.1 - Microsoft* Visual Studio 2017 compatibility /Qgcc-dialect: enable a limited gcc-compatible dialect on Windows. The gcc version may be specified as 440, 450, 460, 470, 480 or 490. Example: /Qgcc-dialect:440 -> gcc 4.4 compatibility Linking/Linker -------------- /link specify that all options following '/link' are for the linker /F set the stack reserve amount specified to the linker /LD[d] produce a DLL instead of an EXE ('d' = debug version) /MD[d] use dynamically-loaded, multithread C runtime /MT[d] use statically-linked, multithread C runtime (DEFAULT with Microsoft Visual Studio 2005 and later) /Zl omit library names from object file Deprecated Options ------------------ /Quse-asm No replacement /Qvc11 No replacement /Qcilk-serialize No replacement /Qopenmp-task= use OpenMP* tasking scheme /arch:SSE use /arch:IA32 /arch:ICELAKE use /arch:ICELAKE-CLIENT /QxSSE3_ATOM use /QxATOM_SSSE3 /QxSSSE3_ATOM use /QxATOM_SSSE3 /QxICELAKE use /QxICELAKE-CLIENT /QaxICELAKE use /QaxICELAKE-CLIENT /Fr use /FR /GX use /EHsc /GZ use /RTC1 /H No replacement /Qwn use /Qdiag-error-limit: /Qwd use /Qdiag-disable /Qwe use /Qdiag-error /Qww use /Qdiag-warning /Qwr use /Qdiag-remark /Qwo use /Qdiag-once /Yd use /Zi, /ZI, /Z7 /Ze No replacement /Zg No replacement /help, /? [category] print full or category help message Valid categories include advanced - Advanced Optimizations codegen - Code Generation compatibility - Compatibility component - Component Control data - Data deprecated - Deprecated Options diagnostics - Compiler Diagnostics float - Floating Point help - Help inline - Inlining ipo - Interprocedural Optimization (IPO) language - Language link - Linking/Linker misc - Miscellaneous opt - Optimization output - Output pgo - Profile Guided Optimization (PGO) preproc - Preprocessor reports - Optimization Reports openmp - OpenMP and Parallel Processing Copyright (C) 1985-2018, Intel Corporation. All rights reserved. * Other names and brands may be claimed as the property of others. Trying C compiler flag -PIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -PIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/PIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -PIC due to icl: command line warning #10006: ignoring unknown option '/PIC' conftest.c Rejected C compiler flag -PIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Trying C compiler flag -fPIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -fPIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/fPIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -fPIC due to icl: command line warning #10006: ignoring unknown option '/fPIC' conftest.c Rejected C compiler flag -fPIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Trying C compiler flag -KPIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -KPIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/KPIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -KPIC due to icl: command line warning #10006: ignoring unknown option '/KPIC' conftest.c Rejected C compiler flag -KPIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Trying C compiler flag -qpic Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -qpic /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/qpic' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -qpic due to icl: command line warning #10006: ignoring unknown option '/qpic' conftest.c Rejected C compiler flag -qpic because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Deleting "LD_SHARED" Checking shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-dynamic'] Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe...found Defined make macro "LD_SHARED" to "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" Trying C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Added C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -dynamic -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10006: ignoring unknown option '/dynamic' Rejecting C linker flag -dynamic due to icl: command line warning #10006: ignoring unknown option '/dynamic' Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int (*fprintf_ptr)(FILE*,const char*,...) = fprintf; void foo(void){ fprintf_ptr(stdout,"hello"); return; } void bar(void){foo();} Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconftest.so -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: LINK : fatal error LNK1561: entry point must be defined Possible ERROR while running linker: exit code 6400 stdout: LINK : fatal error LNK1561: entry point must be defined Rejected C compiler flag because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-dynamic'] Trying C compiler flag -PIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -PIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/PIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -PIC due to icl: command line warning #10006: ignoring unknown option '/PIC' conftest.c Rejected C compiler flag -PIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-dynamic'] Trying C compiler flag -fPIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -fPIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/fPIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -fPIC due to icl: command line warning #10006: ignoring unknown option '/fPIC' conftest.c Rejected C compiler flag -fPIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-dynamic'] Trying C compiler flag -KPIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -KPIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/KPIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -KPIC due to icl: command line warning #10006: ignoring unknown option '/KPIC' conftest.c Rejected C compiler flag -KPIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-dynamic'] Trying C compiler flag -qpic Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -qpic /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/qpic' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -qpic due to icl: command line warning #10006: ignoring unknown option '/qpic' conftest.c Rejected C compiler flag -qpic because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-dynamic'] Deleting "LD_SHARED" Checking shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-qmkshrobj'] Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe...found Defined make macro "LD_SHARED" to "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" Trying C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Added C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -qmkshrobj -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10006: ignoring unknown option '/qmkshrobj' Rejecting C linker flag -qmkshrobj due to icl: command line warning #10006: ignoring unknown option '/qmkshrobj' Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int (*fprintf_ptr)(FILE*,const char*,...) = fprintf; void foo(void){ fprintf_ptr(stdout,"hello"); return; } void bar(void){foo();} Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconftest.so -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: LINK : fatal error LNK1561: entry point must be defined Possible ERROR while running linker: exit code 6400 stdout: LINK : fatal error LNK1561: entry point must be defined Rejected C compiler flag because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-qmkshrobj'] Trying C compiler flag -PIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -PIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/PIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -PIC due to icl: command line warning #10006: ignoring unknown option '/PIC' conftest.c Rejected C compiler flag -PIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-qmkshrobj'] Trying C compiler flag -fPIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -fPIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/fPIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -fPIC due to icl: command line warning #10006: ignoring unknown option '/fPIC' conftest.c Rejected C compiler flag -fPIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-qmkshrobj'] Trying C compiler flag -KPIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -KPIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/KPIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -KPIC due to icl: command line warning #10006: ignoring unknown option '/KPIC' conftest.c Rejected C compiler flag -KPIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-qmkshrobj'] Trying C compiler flag -qpic Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -qpic /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/qpic' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -qpic due to icl: command line warning #10006: ignoring unknown option '/qpic' conftest.c Rejected C compiler flag -qpic because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-qmkshrobj'] Deleting "LD_SHARED" Checking shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe...found Defined make macro "LD_SHARED" to "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" Trying C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Added C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -shared -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10006: ignoring unknown option '/shared' Rejecting C linker flag -shared due to icl: command line warning #10006: ignoring unknown option '/shared' Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int (*fprintf_ptr)(FILE*,const char*,...) = fprintf; void __declspec(dllexport) foo(void){ fprintf_ptr(stdout,"hello"); return; } void bar(void){foo();} Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconftest.dll -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: Creating library C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\libconftest.lib and object C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\libconftest.exp LINK : fatal error LNK1561: entry point must be defined Possible ERROR while running linker: exit code 6400 stdout: Creating library C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\libconftest.lib and object C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\libconftest.exp LINK : fatal error LNK1561: entry point must be defined Rejected C compiler flag because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Trying C compiler flag -PIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -PIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/PIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -PIC due to icl: command line warning #10006: ignoring unknown option '/PIC' conftest.c Rejected C compiler flag -PIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Trying C compiler flag -fPIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -fPIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/fPIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -fPIC due to icl: command line warning #10006: ignoring unknown option '/fPIC' conftest.c Rejected C compiler flag -fPIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Trying C compiler flag -KPIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -KPIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/KPIC' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -KPIC due to icl: command line warning #10006: ignoring unknown option '/KPIC' conftest.c Rejected C compiler flag -KPIC because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Trying C compiler flag -qpic Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -qpic /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/qpic' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -qpic due to icl: command line warning #10006: ignoring unknown option '/qpic' conftest.c Rejected C compiler flag -qpic because it was not compatible with shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-shared'] Deleting "LD_SHARED" Checking shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl using flags ['-LD'] Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe...found Defined make macro "LD_SHARED" to "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" Trying C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Added C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -LD -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o Valid C linker flag -LD Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int (*fprintf_ptr)(FILE*,const char*,...) = fprintf; void __declspec(dllexport) foo(void){ fprintf_ptr(stdout,"hello"); return; } void bar(void){foo();} Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconftest.dll -LD -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: Creating library C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\libconftest.lib and object C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\libconftest.exp Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" __declspec(dllimport) int foo(void); int main() { int ret = foo(); if (ret) {} ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -L/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -lconftest Using shared linker /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl with flags ['-LD'] and library extension dll Executing: uname -s stdout: CYGWIN_NT-6.1 ================================================================================ TEST checkPIC from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1065) TESTING: checkPIC from config.setCompilers(config/BuildSystem/config/setCompilers.py:1065) Determine the PIC option for each compiler Pushing language C Trying C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Added C compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int (*fprintf_ptr)(FILE*,const char*,...) = fprintf; void foo(void){ fprintf_ptr(stdout,"hello"); return; } void bar(void){foo();} Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconftest.dll -LD -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o Accepted C compiler flag Popping language C Pushing language Cxx Trying Cxx compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Added Cxx compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int (*fprintf_ptr)(FILE*,const char*,...) = fprintf; void foo(void){ fprintf_ptr(stdout,"hello"); return; } void bar(void){foo();} Pushing language C Pushing language C Popping language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconftest.dll -LD -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o Accepted Cxx compiler flag Popping language Cxx Pushing language FC Trying FC compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main end Added FC compiler flag Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: function foo(a) real:: a,x,bar common /xx/ x x=a foo = bar(x) end Pushing language C Pushing language C Popping language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconftest.dll -LD -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol BAR referenced in function FOO C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\libconftest.dll : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol BAR referenced in function FOO C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\libconftest.dll : fatal error LNK1120: 1 unresolved externals Rejected FC compiler flag because shared linker cannot handle it Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort --help stdout: Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Usage: win32fe -- - must be the first argument to win32fe : {cl,icl,df,f90,ifl,bcc32,lib,tlib} cl: Microsoft 32-bit C/C++ Optimizing Compiler icl: Intel C/C++ Optimizing Compiler df: Compaq Visual Fortran Optimizing Compiler f90: Compaq Visual Fortran90 Optimizing Compiler ifl: Intel Fortran Optimizing Compiler ifort: Intel Fortran Optimizing Compiler nvcc: NVIDIA CUDA Compiler Driver bcc32: Borland C++ for Win32 lib: Microsoft Library Manager tlib: Borland Library Manager : --help: Output this help message and help for --path : specifies an addition to the PATH that is required (ex. the location of a required .dll) --use : specifies the variant of to use --verbose: Echo to stdout the translated commandline and other diagnostic information --version: Output version info for win32fe and --wait_for_debugger: Inserts an infinite wait after creation of and outputs PID so one can manually attach a debugger to the current process. In the debugger, one must set: tool::waitfordebugger = 0 to continue the execution normally. --win-l: For compilers, define -lfoo to link foo.lib instead of libfoo.lib --woff: Suppress win32fe specific warning messages ================================================================================= For compilers: win32fe will map the following to their native options: -c: Compile Only, generates an object file with .o extension This will invoke the compiler once for each file listed. -l: Link the file lib.lib or if using --win-l also, .lib -o : Output= context dependent -D: Define -I: Add to the include path -L: Add to the link path -g: Generate debug symbols in objects when specified for compilation, and in executables when specified for linking (some compilers specification at both times for full debugging support). -O: Enable compiletime and/or linktime optimizations. Ex: win32fe cl -g -c foo.c --verbose -Iinclude Note: win32fe will automatically find the system library paths and system include paths, relieving the user of the need to invoke a particular shell. ========================================================================= icl specific help: win32fe uses -nologo by default for nonverbose output. Use the flag: -logo to disable this feature. -g is identical to -Z7. -O is identical to -O2. ========================================================================= Intel(R) Visual Fortran Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 Copyright (C) 1985-2018 Intel Corporation. All rights reserved. Intel(R) Fortran Compiler Help ============================== Intel(R) Compiler includes compiler options that optimize for instruction sets that are available in both Intel(R) and non-Intel microprocessors, but may perform additional optimizations for Intel microprocessors than for non-Intel microprocessors. In addition, certain compiler options for Intel(R) Compiler are reserved for Intel microprocessors. For a detailed description of these compiler options, including the instructions they implicate, please refer to "Intel(R) Compiler User and Reference Guides > Compiler Options." usage: ifort [options] file1 [file2 ...] [/link linker_options] where options represents zero or more compiler options fileN is a Fortran source (.f .for .ftn .f90 .fpp .i .i90), assembly (.asm), object (.obj), static library (.lib), or other linkable file linker_options represents zero or more linker options Notes ----- 1. Many FL32 options are supported; a warning is printed for unsupported options. 2. Intel Fortran compiler options may be placed in your ifort.cfg file. Some options listed are only available on a specific system i32 indicates the feature is available on systems based on IA-32 architecture i64em indicates the feature is available on systems using Intel(R) 64 architecture Compiler Option List -------------------- Optimization ------------ /O1 optimize for maximum speed, but disable some optimizations which increase code size for a small speed benefit /O2 optimize for maximum speed (DEFAULT) /O3 optimize for maximum speed and enable more aggressive optimizations that may not improve performance on some programs /Ox enable maximum optimizations (same as /O2) /Os enable speed optimizations, but disable some optimizations which increase code size for small speed benefit (overrides /Ot) /Ot enable speed optimizations (overrides /Os) /Od disable optimizations /Oy[-] enable/disable using EBP as a general purpose register (no frame pointer) (i32 only) /fast enable /QxHOST /O3 /Qipo /Qprec-div- /fp:fast=2 /Oa[-] assume no aliasing in program /Ow[-] assume no aliasing within functions, but assume aliasing across calls /Qprotect-parens[-] enable/disable(DEFAULT) a reassociation optimization for REAL and COMPLEX expression evaluations by not honoring parenthesis Code Generation --------------- /Qx generate specialized code to run exclusively on processors indicated by as described below SSE2 May generate Intel(R) SSE2 and SSE instructions for Intel processors. Optimizes for the Intel NetBurst(R) microarchitecture. SSE3 May generate Intel(R) SSE3, SSE2, and SSE instructions for Intel processors. Optimizes for the enhanced Pentium(R) M processor microarchitecture and Intel NetBurst(R) microarchitecture. SSSE3 May generate Intel(R) SSSE3, SSE3, SSE2, and SSE instructions for Intel processors. Optimizes for the Intel(R) Core(TM) microarchitecture. SSE4.1 May generate Intel(R) SSE4 Vectorizing Compiler and Media Accelerator instructions for Intel processors. May generate Intel(R) SSSE3, SSE3, SSE2, and SSE instructions and it may optimize for Intel(R) 45nm Hi-k next generation Intel Core(TM) microarchitecture. SSE4.2 May generate Intel(R) SSE4 Efficient Accelerated String and Text Processing instructions supported by Intel(R) Core(TM) i7 processors. May generate Intel(R) SSE4 Vectorizing Compiler and Media Accelerator, Intel(R) SSSE3, SSE3, SSE2, and SSE instructions and it may optimize for the Intel(R) Core(TM) processor family. AVX May generate Intel(R) Advanced Vector Extensions (Intel(R) AVX), Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. CORE-AVX2 May generate Intel(R) Advanced Vector Extensions 2 (Intel(R) AVX2), Intel(R) AVX, SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. CORE-AVX-I May generate Intel(R) Advanced Vector Extensions (Intel(R) AVX), including instructions in Intel(R) Core 2(TM) processors in process technology smaller than 32nm, Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. ATOM_SSE4.2 May generate MOVBE instructions for Intel(R) processors, depending on the setting of option /Qinstruction. May also generate Intel(R) SSE4.2, SSE3, SSE2, and SSE instructions for Intel processors. Optimizes for Intel(R) Atom(TM) processors that support Intel(R) SSE4.2 and MOVBE instructions. ATOM_SSSE3 May generate MOVBE instructions for Intel(R) processors, depending on the setting of option /Qinstruction. May also generate Intel(R) SSSE3, SSE3, SSE2, and SSE instructions for Intel processors. Optimizes for the Intel(R) Atom(TM) processor that support Intel(R) SSE and MOVBE instructions. MIC-AVX512 May generate Intel(R) Advanced Vector Extensions 512 (Intel(R) AVX-512) Foundation instructions, Intel(R) AVX-512 Conflict Detection instructions, Intel(R) AVX-512 Exponential and Reciprocal instructions, Intel(R) AVX-512 Prefetch instructions for Intel(R) processors, and the instructions enabled with CORE-AVX2. Optimizes for Intel(R) processors that support Intel(R) AVX-512 instructions. KNM May generate Quad Fused Multiply Add (QFMA) and Quad Virtual Neural Network Instruction (QVNNI) and the instructions enabled with MIC-AVX512. Optimizes for Intel(R) Xeon Phi(TM) product family processor code named Knights Mill. CORE-AVX512 May generate Intel(R) Advanced Vector Extensions 512 (Intel(R) AVX-512) Foundation instructions, Intel(R) AVX-512 Conflict Detection instructions, Intel(R) AVX-512 Doubleword and Quadword instructions, Intel(R) AVX-512 Byte and Word instructions and Intel(R) AVX-512 Vector Length Extensions for Intel(R) processors, and the instructions enabled with CORE-AVX2. Optimizes for Intel(R) processors that support Intel(R) AVX-512 instructions. COMMON-AVX512 May generate Intel(R) Advanced Vector Extensions 512 (Intel(R) AVX-512) Foundation instructions, Intel(R) AVX-512 Conflict Detection instructions, as well as the instructions enabled with CORE-AVX2. Optimizes for Intel(R) processors that support Intel(R) AVX-512 instructions. BROADWELL CANNONLAKE HASWELL ICELAKE-CLIENT (or ICELAKE) ICELAKE-SERVER IVYBRIDGE KNL KNM SANDYBRIDGE SILVERMONT SKYLAKE SKYLAKE-AVX512 May generate instructions for processors that support the specified Intel(R) microarchitecture code name. Optimizes for Intel(R) processors that support the specified Intel(R) microarchitecture code name. Keywords KNL and SILVERMONT are only available on Windows* and Linux* systems. /QxHost generate instructions for the highest instruction set and processor available on the compilation host machine /Qax[,,...] generate code specialized for processors specified by while also generating generic IA-32 instructions. includes one or more of the following: SSE2 May generate Intel(R) SSE2 and SSE instructions for Intel processors. SSE3 May generate Intel(R) SSE3, SSE2, and SSE instructions for Intel processors. SSSE3 May generate Intel(R) SSSE3, SSE3, SSE2, and SSE instructions for Intel processors. SSE4.1 May generate Intel(R) SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel processors. SSE4.2 May generate Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel processors. AVX May generate Intel(R) Advanced Vector Extensions (Intel(R) AVX), Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. CORE-AVX2 May generate Intel(R) Advanced Vector Extensions 2 (Intel(R) AVX2), Intel(R) AVX, SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. CORE-AVX-I May generate Intel(R) Advanced Vector Extensions (Intel(R) AVX), including instructions in Intel(R) Core 2(TM) processors in process technology smaller than 32nm, Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2, and SSE instructions for Intel(R) processors. CORE-AVX512 May generate Intel(R) Advanced Vector Extensions 512 (Intel(R) AVX-512) Foundation instructions, Intel(R) AVX-512 Conflict Detection instructions, Intel(R) AVX-512 Doubleword and Quadword instructions, Intel(R) AVX-512 Byte and Word instructions and Intel(R) AVX-512 Vector Length Extensions for Intel(R) processors, and the instructions enabled with CORE-AVX2. BROADWELL CANNONLAKE HASWELL ICELAKE-CLIENT (or ICELAKE) ICELAKE-SERVER IVYBRIDGE KNL KNM SANDYBRIDGE SILVERMONT SKYLAKE SKYLAKE-AVX512 May generate instructions for processors that support the specified Intel(R) microarchitecture code name. Optimizes for Intel(R) processors that support the specified Intel(R) microarchitecture code name. Keywords KNL and SILVERMONT are only available on Windows* and Linux* systems. MIC-AVX512 May generate Intel(R) Advanced Vector Extensions 512 (Intel(R) AVX-512) Foundation instructions, Intel(R) AVX-512 Conflict Detection instructions, Intel(R) AVX-512 Exponential and Reciprocal instructions, Intel(R) AVX-512 Prefetch instructions for Intel(R) processors, and the instructions enabled with CORE-AVX2. /arch: generate specialized code to optimize for processors indicated by as described below BROADWELL CANNONLAKE HASWELL ICELAKE-CLIENT (or ICELAKE) ICELAKE-SERVER IVYBRIDGE KNL KNM SANDYBRIDGE SILVERMONT SKYLAKE-AVX512 SKYLAKE May generate instructions for processors that support the specified Intel(R) microarchitecture code name CORE-AVX2 May generate Intel(R) Advanced Vector Extensions 2 (Intel(R) AVX2), Intel(R) AVX, SSE4.2, SSE4.1, SSE3, SSE2, SSE, and SSSE3 instructions CORE-AVX-I May generate Float-16 conversion instructions and the RDRND instruction, Intel(R) Advanced Vector Extensions (Intel(R) AVX), Intel(R) SSE4.2, SSE4.1, SSE3, SSE2, SSE, and SSSE3 instructions AVX May generate Intel(R) AVX, SSE4.2, SSE4.1, SSSE3, SSE3, SSE2 and SSE instructions SSE4.2 May generate Intel(R) SSE4.2, SSE4.1, SSSE3, SSE3, SSE2 and SSE instructions SSE4.1 May generate Intel(R) SSE4.1, SSSE3, SSE3, SSE2 and SSE instructions SSSE3 May generate Intel(R) SSSE3, SSE3, SSE2 and SSE instructions SSE3 May generate Intel(R) SSE3, SSE2 and SSE instructions SSE2 May generate Intel(R) SSE2 and SSE instructions /Qinstruction: Refine instruction set output for the selected target processor [no]movbe - Do/do not generate MOVBE instructions with ATOM_SSSE3 (requires /QxATOM_SSSE3) /guard:cf enable control flow protection mechanism /Qextend-arguments:[32|64] By default, unprototyped scalar integer arguments are passed in 32-bits (sign-extended if necessary). On Intel(R) 64, unprototyped scalar integer arguments may be extended to 64-bits. /Qm32 generate code for IA-32 architecture /Qm64 generate code for Intel(R) 64 architecture /Qstringop-strategy: Override the internal decision heuristic for the particular algorithm to use for inlining string operations. The allowed values for : rep - Expand using 1 "rep" prefix (DEFAULT for /Os) const_size_loop - Expand into an inline loop when size is known at compile time (DEFAULT) libcall - Always use a library call. /Qstringop-inline-threshold: inline calls to memcall-like (memcpy, memset) functions when the number of bytes the functions handle are known at compile time and less than /Qcf-protection[:] Enables Control-flow Enforcement Technology (CET) protection, which defends your program from certain attacks that exploit vulnerabilities. shadow_stack - Enables shadow stack protection branch_tracking - Enables endbranch (EB) generation full - Enables both shadow stack protection and endbranch (EB) generation (same as no ) none - Disables Control-flow Enforcement Technology protection Interprocedural Optimization (IPO) ---------------------------------- /Qip[-] enable(DEFAULT)/disable single-file IP optimization within files /Qipo[n] enable multi-file IP optimization between files /Qipo-c generate a multi-file object file (ipo_out.obj) /Qipo-S generate a multi-file assembly file (ipo_out.asm) /Qip-no-inlining disable full and partial inlining /Qip-no-pinlining disable partial inlining /Qipo-separate create one object file for every source file (overrides /Qipo[n]) /Qipo-jobs specify the number of jobs to be executed simultaneously during the IPO link phase Advanced Optimizations ---------------------- /Qunroll[n] set maximum number of times to unroll loops. Omit n to use default heuristics. Use n=0 to disable the loop unroller /Qunroll-aggressive[-] enables more aggressive unrolling heuristics /Qscalar-rep[-] enable(DEFAULT)/disable scalar replacement (requires /O3) /Qpad[-] enable/disable(DEFAULT) changing variable and array memory layout /Qsafe-cray-ptr Cray pointers do not alias with other variables /Qansi-alias[-] enable(DEFAULT)/disable use of ANSI aliasing rules optimizations; user asserts that the program adheres to these rules /Qcomplex-limited-range[-] enable/disable(DEFAULT) the use of the basic algebraic expansions of some complex arithmetic operations. This can allow for some performance improvement in programs which use a lot of complex arithmetic at the loss of some exponent range. /reentrancy: specify whether the threaded, reentrant run-time support should be used Keywords: none (same as /noreentrancy), threaded(DEFAULT), async /noreentrancy do not use threaded, reentrant run-time support /heap-arrays[:n] temporary arrays of minimum size n (in kilobytes) are allocated in heap memory rather than on the stack. If n is not specified, all temporary arrays are allocated in heap memory. /heap-arrays- temporary arrays are allocated on the stack (DEFAULT) /Qopt-multi-version-aggressive[-] enables more aggressive multi-versioning to check for pointer aliasing and scalar replacement /Qopt-ra-region-strategy[:] select the method that the register allocator uses to partition each routine into regions routine - one region per routine block - one region per block trace - one region per trace loop - one region per loop default - compiler selects best option /Qvec[-] enables(DEFAULT)/disables vectorization /Qvec-guard-write[-] enables cache/bandwidth optimization for stores under conditionals within vector loops /Qvec-threshold[n] sets a threshold for the vectorization of loops based on the probability of profitable execution of the vectorized loop in parallel /Qvecabi: select vector function ABI legacy - use the legacy vector function ABI compat - use the compatibility vector function ABI (DEFAULT) cmdtarget - generate an extended set of vector functions /Qopt-malloc-options:{0|1|2|3|4} specify malloc configuration parameters. Specifying a non-zero value will cause alternate configuration parameters to be set for how malloc allocates and frees memory /Qopt-jump-tables: control the generation of jump tables default - let the compiler decide when a jump table, a series of if-then-else constructs or a combination is generated large - generate jump tables up to a certain pre-defined size (64K entries) - generate jump tables up to in size use /Qopt-jump-tables- to lower switch statements as chains of if-then-else constructs /Qopt-block-factor: specify blocking factor for loop blocking /Qopt-streaming-stores: specifies whether streaming stores are generated always - enables generation of streaming stores under the assumption that the application is memory bound. Also, the user is responsible for inserting the right memory fences for synchronization auto - compiler decides when streaming stores are used (DEFAULT) never - disables generation of streaming stores /Qmkl[:] link to the Intel(R) Math Kernel Library (Intel(R) MKL) and bring in the associated headers parallel - link using the threaded Intel(R) MKL libraries. This is the default when /Qmkl is specified sequential - link using the non-threaded Intel(R) MKL libraries cluster - link using the Intel(R) MKL Cluster libraries plus the sequential Intel(R) MKL libraries /Qimsl link to the International Mathematics and Statistics Library* (IMSL* library) /Qopt-subscript-in-range[-] assumes no overflows in the intermediate computation of the subscripts /Qcoarray[:] enable/disable(DEFAULT) coarray syntax for data parallel programming, and set the relationship between the coarray images. keywords: shared - default if keyword is omitted single - overrides any other keyword distributed - only valid with the Intel(R) Cluster Toolkit coprocessor - Intel(R) 64 Linux only /Qcoarray-num-images:n set default number of coarray images /Qopt-matmul[-] replace matrix multiplication with calls to intrinsics and threading libraries for improved performance (DEFAULT at /O3 /Qparallel) /Qsimd[-] enables(DEFAULT)/disables vectorization using SIMD directive /Qguide-opts: tells the compiler to analyze certain code and generate recommendations that may improve optimizations /Qguide-file[:] causes the results of guide to be output to a file /Qguide-file-append[:] causes the results of guide to be appended to a file /Qguide[:] lets you set a level (1 - 4) of guidance for auto-vectorization, auto-parallelization, and data transformation (DEFAULT is 4 when the option is specified) /Qguide-data-trans[:] lets you set a level (1 - 4) of guidance for data transformation (DEFAULT is 4 when the option is specified) /Qguide-par[:] lets you set a level (1 - 4) of guidance for auto-parallelization (DEFAULT is 4 when the option is specified) /Qguide-par[:] lets you set a level (1 - 3) of guidance for auto-parallelization (DEFAULT is 2 when the option is specified) /Qguide-vec[:] lets you set a level (1 - 4) of guidance for auto-vectorization (DEFAULT is 4 when the option is specified) /Qguide-profile:<[file|dir]>[,[file|dir],...] specify a loop profiler data file (or set of files in a directory) when using the /Qguide option /Qopt-mem-layout-trans[:] controls the level of memory layout transformations performed by the compiler 0 - disable memory layout transformations (same as /Qopt-mem-layout-trans-) 1 - enable basic memory layout transformations 2 - enable more memory layout transformations (DEFAULT when the option is specified) 3 - enable aggressive memory layout transformations /Qopt-prefetch[:n] enable levels of prefetch insertion, where 0 disables. n may be 0 through 5 inclusive. Default is 2. /Qopt-prefetch- disable(DEFAULT) prefetch insertion. Equivalent to /Qopt-prefetch:0 /Qopt-prefetch-distance:n1[,n2] specify the prefetch distance (how many iterations ahead, use n1 and n2 values such that n1>=n2) to be used for compiler generated prefetches inside loops. n1 indicates distance from memory to L2 cache and n2 indicates distance from L2 to L1. /Qopt-prefetch-issue-excl-hint generates PrefetchW instruction for Intel(R) microarchitecture code name Broadwell processors and beyond when /Qopt-prefetch is also used /Qopt-gather-scatter-unroll:n specify an alternative loop unroll sequence for gather and scatter loops (Intel(R) MIC Architecture specific). Disable with /Qopt-gather-scatter-unroll- (equivalent to n=0) /Qopt-dynamic-align enable(DEFAULT) dynamic data alignment optimizations. Specify /Qopt-dynamic-align- to disable /Qalign-loops[:n] specify code alignment of loops to improve performance. n is the number of bytes for the minimum alignment boundary. It must be a power of 2 between 1 and 4096. If n is not present, an alignment of 16 bytes is used. Use of /Qalign-loops- (DEFAULT) sets alignment to 1. /Qopt-zmm-usage: Specifies the level of zmm registers usage. You can specify one of the following: low - Tells the compiler that the compiled program is unlikely to benefit from zmm registers usage. It specifies that the compiler should avoid using zmm registers unless it can prove the gain from their usage. high - Tells the compiler to generate zmm code without restrictions /Qoverride-limits provides a way to override certain internal compiler limits that are intended to prevent excessive memory usage or compile times for very large, complex compilation units. Profile Guided Optimization (PGO) --------------------------------- /Qprof-dir specify directory for profiling output files (*.dyn and *.dpi) /Qprof-src-root specify project root directory for application source files to enable relative path resolution during profile feedback on sources below that directory /Qprof-src-root-cwd specify the current directory as the project root directory for application source files to enable relative path resolution during profile feedback on sources below that directory /Qprof-src-dir[-] specify whether directory names of sources should be considered when looking up profile records within the .dpi file /Qprof-file specify file name for profiling summary file /Qprof-data-order[-] enable/disable(DEFAULT) static data ordering with profiling /Qprof-func-order[-] enable/disable(DEFAULT) function ordering with profiling /Qprof-gen[:keyword[,keyword]] instrument program for profiling. Optional keywords are as follows. default - Produces an instrumented object file. This is the same as specifying the /Qprof-gen option with no keyword. srcpos - Produces an instrumented object file and information needed for using the code coverage tool. globdata - Produces an instrumented object file that includes information for global data layout. threadsafe - Collects PGO data with guards for threaded applications. /Qprof-gen- disable profiling instrumentation /Qprof-use[:] enable use of profiling information during optimization weighted - invokes profmerge with -weighted option to scale data based on run durations [no]merge - enable(default)/disable the invocation of the profmerge tool /Qprof-use- disable use of profiling information during optimization /Qcov-gen instrument program for profiling. Use /Qcov-gen- to disable /Qcov-dir specify directory for profiling output files (*.dyn and *.dpi) /Qcov-file specify file name for profiling summary file /Qfnsplit[:] enable function splitting (enabled with /Qprof-use for IA-32 Windows) n - positive integer indicating the threshold number. The blocks can be placed into a different code segment if their execution probability is less than the specified value of range 0 <= n <= 100 use /Qfnsplit- to disable /Qinstrument-functions[-] determine whether function entry and exit points are instrumented /Qprof-hotness-threshold: set the hotness threshold for function grouping and function ordering val indicates percentage of functions to be placed in hot region. This option requires /Qprof-use and /Qprof-func-order /Qprof-value-profiling:[,,...] limit value profiling none - inhibit all types of value profiling nodivide - inhibit value profiling of non-compile time constants used in division or remainder operations noindcall - inhibit value profiling of function addresses at indirect call sites /Qprofile-functions enable instrumentation in generated code for collecting function execution time profiles /Qprofile-loops: enable instrumentation in generated code for collecting loop execution time profiles inner - instrument inner loops outer - instrument outer loops all - instrument all loops /Qprofile-loops-report: Control the level of instrumentation inserted for reporting loop execution profiles 1 - report loop times 2 - report loop times and iteration counts Optimization Reports -------------------- /Qopt-report[:n] generate an optimization report. Default destination is .optrpt. Levels of 0 - 5 are valid. Please see documentation for additional details of information provided by phase per level. 0 disable optimization report output 2 DEFAULT when enabled /Qopt-report-file:[stdout | stderr | ] specify the filename or output stream for the generated report /Qopt-report-stdout specify the generated report should be directed to stdout /Qopt-report-per-object specify the generated report should be directed to a .optrpt file in the output directory (DEFAULT when another destination for the report is not specified) /Qopt-report-phase:[,,...] specify one or more phases that reports are generated against /Qopt-report-routine:[,,...] restrict the report to routines containing the given name /Qopt-report-filter: restricts the opt-report to specific files, routines or line number ranges. Refer to the documentation for the specific syntax of parameter string. /Qopt-report-format:[text|vs] specify the output format to be used for the opt-report as either plain text or a format for use in the Microsoft* Visual Studio IDE /Qopt-report-embed[-] When enabled, if an assembly file is being generated, special loop info annotations will be emitted in the assembly file. If an object file/executable is being generated, these will be emitted into the object file/executable for use by the Intel VTune Amplifier application. Automatically enabled when symbolic debug information is enabled. /Qopt-report-help display the optimization phases available for reporting /Qopt-report-names: Specifies whether mangled or unmangled names should appear in the optimization report. mangled - use mangled names unmangled - use unmangled names (DEFAULT) /Qopt-report-annotate[:] Annotate source files with optimization reports in specified format html - annotate in HTML format text - annotate in text format (DEFAULT) /Qopt-report-annotate-position: Specify the site where loop related optimization reports appear in the annotated source for inlined routines caller - annotate at caller site callee - annotate at callee site both - annotate at both caller and callee site /Qtcheck[:mode] enable analysis of threaded applications (requires Intel(R) Thread Checker; cannot be used with compiler alone) tci - instruments a program to perform a thread-count-independent analysis tcd - instruments a program to perform a thread-count-dependent analysis (DEFAULT when mode is not used) api - instruments a program at the api-imports level /Qtcollect[:] inserts instrumentation probes calling the Intel(R) Trace Collector API. The library .lib is linked in the default being VT.lib (requires Intel(R) Trace Collector) /Qtcollect-filter:file Enable or disable the instrumentation of specified functions. (requires Intel(R) Trace Collector) OpenMP* and Parallel Processing ------------------------------ /Qopenmp enable the compiler to generate multi-threaded code based on the OpenMP* directives (same as /openmp) Use /Qopenmp- to disable /Qopenmp-stubs enables the user to compile OpenMP programs in sequential mode. The OpenMP directives are ignored and a stub OpenMP library is linked (sequential) /Qopenmp-lib: choose which OpenMP library version to link with compat - use the Microsoft compatible OpenMP run-time libraries (DEFAULT) /Qopenmp-threadprivate: choose which threadprivate implementation to use compat - use the Microsoft compatible thread local storage legacy - use the Intel compatible implementation (DEFAULT) /Qparallel enable the auto-parallelizer to generate multi-threaded code for loops that can be safely executed in parallel /Qpar-threshold[n] set threshold for the auto-parallelization of loops where n is an integer from 0 to 100 /Qpar-runtime-control[n] Control parallelizer to generate runtime check code for effective automatic parallelization. n=0 no runtime check based auto-parallelization n=1 generate runtime check code under conservative mode (DEFAULT when enabled) n=2 generate runtime check code under heuristic mode n=3 generate runtime check code under aggressive mode /Qpar-schedule-static[:n] Specifies a scheduling algorithm for DO loop iteration. Divides iterations into contiguous pieces. Size n if specified, equal sized pieces if not. /Qpar-schedule-static-balanced[:n] Divides iterations into even-sized chunks. Size n if specified, equal sized pieces if not. /Qpar-schedule-static-steal[:n] Divides iterations into even-sized chunks, but allows threads to steal parts of chunks from neighboring threads /Qpar-schedule-dynamic[:n] Specifies a scheduling algorithm for DO loop iteration. Assigns iterations to threads in chunks dynamically. Chunk size is n iterations if specified, otherwise 1. /Qpar-schedule-guided[:n] Specifies a scheduling algorithm for DO loop iteration. Indicates a minimum number of iterations. If specified, n is the minimum number, otherwise 1. /Qpar-schedule-guided-analytical[:n] Divides iterations by using exponential distribution or dynamic distributions. /Qpar-schedule-runtime Specifies a scheduling algorithm for DO loop iteration. Defers the scheduling decision until runtime. /Qpar-schedule-auto Lets the compiler or run-time system determine the scheduling algorithm. /Qpar-adjust-stack perform fiber-based main thread stack adjustment /Qpar-affinity=[,...][,][,] tune application performance by setting different thread affinity /Qpar-num-threads= tune application performance by setting different number of threads /Qparallel-source-info[:n] enable(DEFAULT)/disable the emission of source location information for parallel code generation with OpenMP and auto-parallelization 0 - disable (same as /Qparallel-source-info-) 1 - emit routine name and line information (DEFAULT) 2 - emit path, file, routine name and line information /Qpar same as /Qparallel /Qopenmp-simd Enables OpenMP* SIMD compilation. Enabled by default with /Qopenmp. Use /Qopenmp-simd- to disable. /Qopenmp-offload[:] Enables OpenMP* offloading compilation for TARGET directives. Enabled for Intel(R) MIC Architecture by default with /Qopenmp. Use /Qopenmp-offload- to disable. Specify kind to specify the default device for TARGET directives. host - allow target code to run on host system while still doing the outlining for offload mic - specify Intel(R) MIC Architecture (DEFAULT) Floating Point -------------- /fp: enable floating point model variation except[-] - enable/disable floating point exception semantics fast[=1|2] - enables more aggressive floating point optimizations precise - allows value-safe optimizations source - enables intermediates in source precision sets /assume:protect_parens for Fortran strict - enables /fp:precise /fp:except, disables contractions and enables pragma stdc fenv_access consistent - enables consistent, reproducible results for different optimization levels or between different processors of the same architecture /Qfp-speculation: enable floating point speculations with the following conditions: fast - speculate floating point operations (DEFAULT) safe - speculate only when safe strict - same as off off - disables speculation of floating-point operations /Qpc32 set internal FPU precision to 24 bit significand /Qprec improve floating-point precision /Qprec-sqrt[-] determine if certain square root optimizations are enabled /Qprec-div[-] improve precision of FP divides (some speed impact) /Qfast-transcendentals[-] generate a faster version of the transcendental functions /Qfp-port[-] round fp results at assignments and casts (some speed impact) /Qfp-stack-check enable fp stack checking after every function/procedure call /Qrcd rounding mode to enable fast float-to-int conversions /rounding-mode:chopped set internal FPU rounding control to truncate /Qftz[-] enable/disable flush denormal results to zero /fpe:{0|1|3} specifies program-wide behavior on floating point exceptions /fpe-all:{0|1|3} specifies floating point exception behavior on all functions and subroutines. Also sets /assume:ieee_fpe_flags /[no]fltconsistency specify that improved floating-point consistency should be used /Qfma[-] enable/disable the combining of floating point multiplies and add/subtract operations /[no]recursive compile all procedures for possible recursive execution /Qimf-absolute-error:value[:funclist] define the maximum allowable absolute error for math library function results value - a positive, floating-point number conforming to the format [digits][.digits][{e|E}[sign]digits] funclist - optional comma separated list of one or more math library functions to which the attribute should be applied /Qimf-accuracy-bits:bits[:funclist] define the relative error, measured by the number of correct bits, for math library function results bits - a positive, floating-point number funclist - optional comma separated list of one or more math library functions to which the attribute should be applied /Qimf-arch-consistency:value[:funclist] ensures that the math library functions produce consistent results across different implementations of the same architecture value - true or false funclist - optional comma separated list of one or more math library functions to which the attribute should be applied /Qimf-max-error:ulps[:funclist] defines the maximum allowable relative error, measured in ulps, for math library function results ulps - a positive, floating-point number conforming to the format [digits][.digits][{e|E}[sign]digits] funclist - optional comma separated list of one or more math library functions to which the attribute should be applied /Qimf-precision:value[:funclist] defines the accuracy (precision) for math library functions value - defined as one of the following values high - equivalent to max-error = 0.6 medium - equivalent to max-error = 4 (DEFAULT) low - equivalent to accuracy-bits = 11 (single precision); accuracy-bits = 26 (double precision) funclist - optional comma separated list of one or more math library functions to which the attribute should be applied /Qimf-domain-exclusion:classlist[:funclist] indicates the input arguments domain on which math functions must provide correct results. classlist - defined as one of the following values: nans, infinities, denormals, zeros all, none, common funclist - optional list of one or more math library functions to which the attribute should be applied. /Qimf-force-dynamic-target[:funclist] Instructs the compiler to use run-time dispatch in calls to math functions funclist - optional list of one or more math library functions to which the attribute should be applied. /Qfinite-math-only Allow optimizations for floating point arithmetic that assume arguments and results are not NaNs or Infinities Inlining -------- /Ob control inline expansion: n=0 disable inlining (same as /inline:none) n=1 inline functions declared with ATTRIBUTES INLINE or FORCEINLINE n=2 inline any function, at the compiler's discretion /Qinline-min-size: set size limit for inlining small routines /Qinline-min-size- no size limit for inlining small routines /Qinline-max-size: set size limit for inlining large routines /Qinline-max-size- no size limit for inlining large routines /Qinline-max-total-size: maximum increase in size for inline function expansion /Qinline-max-total-size- no size limit for inline function expansion /Qinline-max-per-routine: maximum number of inline instances in any function /Qinline-max-per-routine- no maximum number of inline instances in any function /Qinline-max-per-compile: maximum number of inline instances in the current compilation /Qinline-max-per-compile- no maximum number of inline instances in the current compilation /Qinline-factor: set inlining upper limits by n percentage /Qinline-factor- do not set set inlining upper limits /Qinline-forceinline treat inline routines as forceinline /Qinline-dllimport allow(DEFAULT)/disallow functions declared DEC$ ATTRIBUTES DLLIMPORT to be inlined /Qinline-calloc directs the compiler to inline calloc() calls as malloc()/memset() /inline[:keyword] Specifies the level of inline function expansion keywords: all (same as /Ob2 /Ot), size (same as /Ob2 /Os) speed (same as /Ob2 /Ot), none or manual (same as /Ob0) /Qinline-min-caller-growth: set lower limit on caller growth due to inlining a single routine /Qinline-min-caller-growth- no lower limit on caller growth due to inlining a single routine Output, Debug, PCH ------------------ /c compile to object (.obj) only, do not link /nolink, /compile-only same as /c /S compile to assembly (.asm) only, do not link /FAs produce assembly file with optional source annotations /FAc produce assembly file with optional code annotations /FA produce assembly file /Fa[file] name assembly file (or directory for multiple files; i.e. /FaMYDIR\) /Fo[file] name object file (or directory for multiple files; i.e. /FoMYDIR\) /Fe[file] name executable file or directory /Fi[file] name preprocessed file (or directory for multiple files; i.e. /FiMYDIR\) /object: specify the name of the object file, or the directory to which object file(s) should be written. (e.g. /object:MYOBJ or /object:MYDIR\) /exe: specifies the name to be used for the built program (.exe) or dynamic-link (.dll) library /map: specify that a link map file should be generated /list[:] specify that a listing file should be generated /list-line-len:# overrides the default line length (80) in a listing file /list-page-len:# overrides the default page length (66) in a listing file /show: controls the contents of the listing file keywords: all, none, [no]include, [no]map, [no]options /Zi, /ZI, /Z7 Produce symbolic debug information. The /Zi and /ZI flags emit the debug information for types into a separate PDB file. /Zo[-] When symbolic debug information is being produced, enable/disable emission of additional symbolic debug information to describe optimized code. /debug[:keyword] Control the emission of debug information. Valid [keyword] values: none Disables debug generation. all, full (default if no keyword was specified) Generates complete debug information. minimal Generates line number information. [no]inline-debug-info Controls additional debug information for inlined code. /nodebug Disable emission of debug information. /debug-parameters[:keyword] Control output of debug information for PARAMETERS. Valid [keyword] values: none - Disables generation of debug information for PARAMETERs. used - Generates debug information for referenced PARAMETERs only. all - Generates debug information for all PARAMETERs. /nodebug-parameters Same as "/debug-parameters:none". /Qd-lines, /[no]d-lines compile debug statements (indicated by D in column 1) /pdbfile[:filename] Specify that debug related type information should be generated to a program database file at link time. /nopdbfile Do not generate debug related information to a program database file. /Qtrapuv trap uninitialized variables /RTCu report use of variable that was not initialized /Qmap-opts enable option mapping tool /Qeliminate-unused-debug-types[-] When disabled, debug information for all types present in the sources will be emitted. Using this option may cause a large increase in the size of the debug information. /Qemit-build-options Output the options used during the compilation to a corresponding .dashboard file. This file is to be consumed by the dbmerge tool and used by the dashboard tool. /Qemit-messages Output the diagnostics emitted during the compilation to a corresponding .dashboard file. This file is to be consumed by the dbmerge tool and used by the dashboard tool. Preprocessor ------------ /D[{=|#}] define macro /define:symbol[=] same as /D /nodefines specifies that any /D macros go to the preprocessor only, and not to the compiler /U remove predefined macro /undefine: remove predefined macro (same as /U) /allow:nofpp-comments If a Fortran end-of-line comment is seen within a #define, treat it as part of the definition. Default is allow:fpp-comments /E preprocess to stdout /EP preprocess to stdout, omitting #line directives /EP /P preprocess to file, omitting #line directives /P preprocess to file /preprocess-only same as /P /[no]keep keep/remove preprocessed file generated by preprocessor as input to compiler stage. Not affected by /Qsave-temps. Default is /nokeep /[no]fpp run Fortran preprocessor on source files prior to compilation /fpp-name:name Name an alternate preprocessor executable. The name can include the full path. /module:path specify path where mod files should be placed and first location to look for mod files /u remove all predefined macros /I add directory to include file search path /[no]include: same as /I /X remove standard directories from include file search path /gen-dep[:filename] generate dependency information. If no filename is specified, output is to stdout. Similar to /QMD or /QMMD If a filename is specified, output is to filename. Similar to /QMF filename /gen-dep- do not generate dependency information (default) /gen-depshow:keyword control what dependency information is output. [no]intr_mod Intrinsic modules. Default is nointr_mod. /gen-depformat:keyword generate dependency information in the specified format. One of: make, nmake Component Control ----------------- /Qoption,, pass options to tool specified by /Qlocation,, set as the location of tool specified by Language -------- /[no]altparam specify if alternate form of parameter constant declarations (without parenthesis) is recognized. Default is to recognize /assume: specify assumptions made by the optimizer and code generator keywords: none, [no]byterecl, [no]buffered_io, [no]buffered_stdout, [no]bscc (nobscc same as /nbs), [no]contiguous_pointer, [no]contiguous_assumed_shape, [no]cc_omp, [no]minus0, [no]dummy_aliases (same as /Qcommon-args), [no]ieee_fpe_flags, [no]fpe_summary, [no]old_boz, [no]old_complex_align, [no]old_logical_ldio, [no]old_logical_assign, [no]old_ldout_format, [no]old_maxminloc, [no]old_unit_star, [no]old_xor, [no]protect_allocates, [no]protect_constants, [no]protect_parens, [no]realloc_lhs, [no]2underscore, [no]underscore (same as /us), [no]std_intent_in, [no]std_minus0_rounding, [no]std_mod_proc_name, [no]std_value, [no]source_include, [no]split_common, [no]writeable_strings /ccdefault: specify default carriage control for units 6 and * keywords: default, fortran, list or none /[no]check: check run-time conditions. Default is /nocheck keywords: all (same as /4Yb, /C), none (same as /nocheck, /4Nb), [no]arg_temp_created, [no]bounds (same as /CB), [no]contiguous, [no]format, [no]output_conversion, [no]pointers (same as /CA), [no]assume, [no]uninit (same as /CU), [no]stack /Qcommon-args assume "by reference" subprogram arguments may alias one another. Same as /assume:dummy_aliases /[no]extend-source[:] specify rightmost column for fixed form sources keywords: 72 (same as /noextend-source and /4L72), 80 (same as /4L80), 132 (same as /4L132. Default if you specify /extend-source without a keyword.) /fixed specify source files are in fixed format. Same as /FI and /4Nf /nofixed indicates free format /free specify source files are in free format. Same as /FR and /4Yf /nofree indicates fixed format /names: specify how source code identifiers and external names are interpreted. keywords: as_is, lowercase, uppercase /[no]pad-source, /Qpad-source[-] make compiler acknowledge blanks at the end of a line /stand[:] specifies level of conformance with ANSI standard to check for. If keyword is not specified, level of conformance is f08 keywords: f90 (same as /4Ys), f95, f03, f08, f15, none (same as /nostand) /standard-semantics explicitly sets assume keywords to conform to the semantics of the Fortran standard. May result in performance loss. assume keywords set by /standard-semantics: byterecl, fpe_summary, minus0, noold_ldout_format, noold_maxminloc, noold_unit_star, noold_xor, protect_parens, realloc_lhs, std_intent_in, std_minus0_rounding, std_mod_proc_name, std_value also sets /fpscomp:logicals If /fp:strict or /fp:except is set then this also sets assume keyword ieee_fpe_flags /[no]standard-realloc-lhs explicitly sets assume keyword realloc_lhs to conform to the standard, or to override the default. Sets /assume:[no]realloc_lhs /syntax-only, /Zs perform syntax and semantic checking only (no object file produced) /wrap-margin[-] controls right margin wrapping in list-directed output. By default, list-directed output is wrapped at 80 characters. Compiler Diagnostics -------------------- /w disable all warnings /W disable warnings (n = 0) or show warnings (n = 1 DEFAULT, same as /warn:general) /warn: specifies the level of warning messages issued keywords: all, none (same as /nowarn) [no]alignments, [no]declarations, [no]errors, [no]general, [no]ignore_loc, [no]interfaces, [no]stderrors, [no]truncated_source, [no]uncalled, [no]unused, [no]usage /nowarn suppress all warning messages /WB turn a compile-time bounds check into a warning /[no]traceback specify whether the compiler generates PC correlation data used to display a symbolic traceback rather than a hexadecimal traceback at runtime failure /[no]gen-interfaces [[no]source] generate interface blocks for all routines in the file. Can be checked using -warn interfaces nosource indicates temporary source files should not be saved /error-limit: specify the maximum number of error-level or fatal-level compiler errors allowed /noerror-limit set no maximum number on error-level or fatal-level error messages /Qdiag-enable:[,,...] enable the specified diagnostics or diagnostic groups /Qdiag-disable:[,,...] disable the specified diagnostics or diagnostic groups where may be individual diagnostic numbers or group names. where group names include: openmp - diagnostics issued by the OpenMP* parallelizer warn - diagnostics that have "warning" severity level error - diagnostics that have "error" severity level remark - diagnostics that are remarks or comments vec - diagnostics issued by the vectorizer par - diagnostics issued by the auto-parallelizer cpu-dispatch - specifies the CPU dispatch remarks /Qdiag-error:[,,...] output the specified diagnostics or diagnostic groups as errors /Qdiag-warning:[,,...] output the specified diagnostics or diagnostic groups as warnings /Qdiag-remark:[,,...] output the the specified diagnostics or diagnostic groups as remarks /Qdiag-dump display the currently enabled diagnostic messages to stdout or to a specified diagnostic output file. /Qdiag-file[:] where diagnostics are emitted to. Not specifying this causes messages to be output to stderr /Qdiag-file-append[:] where diagnostics are emitted to. When already exists, output is appended to the file /Qdiag-id-numbers[-] enable(DEFAULT)/disable the diagnostic specifiers to be output in numeric form /Qdiag-error-limit: specify the maximum number of errors emitted Miscellaneous ------------- /[no]logo display compiler version information. /nologo disables the output /bintext: place the string specified into the object file and executable /Qsave-temps store the intermediate files in current directory and name them based on the source file. Only saves files that are generated by default /what display detailed compiler version information /watch: tells the driver to output processing information keywords: all, none (same as /nowatch), [no]source, [no]cmd [no]mic-cmd /nowatch suppress processing information output (DEFAULT) /Tf compile file as Fortran source /extfor: specify extension of file to be recognized as a Fortran file /extfpp: specify extension of file to be recognized as a preprocessor file /libdir[:keyword] control the library names that should be emitted into the object file keywords: all, none (same as /nolibdir), [no]automatic, [no]user /nolibdir no library names should be emitted into the object file /MP[] create multiple processes that can be used to compile large numbers of source files at the same time /bigobj generate objects with increased address capacity /Qoffload: define whether offload is enabled, and if enabled, whether CPU fallback is permitted keywords: none, optional, mandatory /Qoffload-attribute-target: flags every global routine and global data object in the source file with the offload attribute target() name - mic, gfx (gfx for C/C++ compilation only) /Qoffload-option,,,"option list" appends additional options for offload compilations given the target and tool. The option list is a space separated quoted list of options target - mic, gfx (gfx for C/C++ compilation only) tool - compiler, link, asm, jit (gfx only) /Qoffload- disable any offload usage /Qoffload-arch:[:] specify the target architecture to use when offloading code arch - Specifies the target architecture. On Intel(R) 64 architecture targeting Intel(R) MIC Architecture, arch can be mic-avx512. On IA-32 and Intel(R) 64 architectures targeting Intel(R) Graphics Technology, arch can be haswell, broadwell, cherryview, skylake, or broxton. visa - Specifies the virtual ISA (vISA) version to be used. This optional argument is only allowed on IA-32 and Intel(R) 64 architectures targeting Intel(R) Graphics Technology. You can specify either visa3.1 or visa3.2. Data ---- /4I{2|4|8} set default KIND of integer and logical variables to 2, 4, or 8 /integer-size: specifies the default size of integer and logical variables size: 16, 32, 64 /4R{8|16} set default size of real to 8 or 16 bytes /real-size: specify the size of REAL and COMPLEX declarations, constants, functions, and intrinsics size: 32, 64, 128 /Qautodouble same as /real-size:64 or /4R8 /double-size: defines the size of DOUBLE PRECISION and DOUBLE COMPLEX declarations, constants, functions, and intrinsics size: 64, 128 /[no]fpconstant extends the precision of single precision constants assigned to double precision variables to double precision /[no]intconstant use Fortran 77 semantics, rather than Fortran 90/95, to determine kind of integer constants /auto make all local variables AUTOMATIC /Qauto-scalar make scalar local variables AUTOMATIC (DEFAULT) /Qsave save all variables (static allocation) (same as /noauto, opposite of /auto) /Qzero[-] enable/disable(DEFAULT) implicit initialization to zero of local scalar variables of intrinsic type INTEGER, REAL, COMPLEX, or LOGICAL that are saved and not initialized /Qinit: enable/disable(DEFAULT) implicit initialization of local variables of intrinsic type INTEGER, REAL, COMPLEX, or LOGICAL that are saved and not initialized The specifies the initial value keywords: zero (same as /Qzero), snan (valid only for floating point variables), infinity, minus_infinity (valid only for floating point) tiny, minus_tiny (valid only for floating point) huge, minus_huge arrays /Qdyncom make given common blocks dynamically-allocated /Zp[n] specify alignment constraint for structures (n=1,2,4,8,16 /Zp16 DEFAULT) /[no]align analyze and reorder memory layout for variables and arrays /align: specify how data items are aligned keywords: all (same as /align), none (same as /noalign), [no]commons, [no]dcommons, [no]qcommons, [no]zcommons, rec1byte, rec2byte, rec4byte, rec8byte, rec16byte, rec32byte, array8byte, array16byte, array32byte, array64byte, array128byte, array256byte, [no]records, [no]sequence /GS enable overflow security checks. Optional can specify: partial - provide a stack protection level that is compatible with Microsoft* Visual Studio 2008. strong - provide full stack security level checking. This setting is compatible with recent Microsoft* Visual Studio stack protection heuristics. This is the same as specifying /GS with no keyword. off - Same as /GS- (DEFAULT) /Qpatchable-addresses generate code such that references to statically assigned addresses can be patched with arbitrary 64-bit addresses. /Qglobal-hoist[-] enable(DEFAULT)/disable external globals are load safe /Qkeep-static-consts[-] enable/disable(DEFAULT) the ability to preserve allocation of variables that are not referenced in the source /Qnobss-init disable placement of zero-initialized variables in BSS (use DATA) /Qzero-initialized-in-bss[-] put explicitly zero initialized variables into the DATA section instead of the BSS section /convert: specify the format of unformatted files containing numeric data keywords: big_endian, cray, ibm, little_endian, native, vaxd, vaxg /Qfnalign: align the start of functions on a 2 (DEFAULT) or byte boundary where is a power of 2 /Qfnalign align the start of functions to an optimal machine-dependent value. /Qfnalign- (DEFAULT) aligns on a 2-byte boundary Compatibility ------------- /fpscomp[:] specify the level of compatibility to adhere to with Fortran PowerStation keywords: all, none (same as /nofpscomp), [no]filesfromcmd, [no]general, [no]ioformat, [no]ldio_spacing, [no]libs, [no]logicals /nofpscomp no specific level of compatibility with Fortran PowerStation /f66 allow extensions that enhance FORTRAN-66 compatibility /f77rtl specify that the Fortran 77 specific run-time support should be used /nof77rtl disables /vms enable VMS I/O statement extensions /Qvc enable compatibility with a specific Microsoft* Visual Studio version 12 - Microsoft* Visual Studio 2013 compatibility 14 - Microsoft* Visual Studio 2015 compatibility 14.1 - Microsoft* Visual Studio 2017 compatibility Linking/Linker -------------- /link specify that all options following '/link' are for the linker /extlnk: specify extension of file to be passed directly to linker /F set the stack reserve amount specified to the linker /dbglibs use the debug version of runtime libraries, when appropriate /libs: specifies which type of run-time library to link to. keywords: static, dll, qwin, qwins /LD[d] produce a DLL instead of an EXE ('d' = debug version) /dll same as /LD /MD[d] use dynamically-loaded, multithread C runtime /MDs[d] use dynamically-loaded, singlethread Fortran runtime, and multithread C runtime /MT[d] use statically-linked, multithread C runtime (DEFAULT with Microsoft Visual Studio 2005 and later) /MG, /winapp use Windows API runtime libraries /Zl omit library names from object file /threads specify that multi-threaded libraries should be linked against /nothreads disables multi-threaded libraries Deprecated Options ------------------ /Quse-asm No replacement /Qvc11 No replacement /Qcilk-serialize No replacement /Qopenmp-task= use OpenMP* tasking scheme /arch:SSE use /arch:IA32 /arch:ICELAKE use /arch:ICELAKE-CLIENT /QxSSE3_ATOM use /QxATOM_SSSE3 /QxSSSE3_ATOM use /QxATOM_SSSE3 /QxICELAKE use /QxICELAKE-CLIENT /QaxICELAKE use /QaxICELAKE-CLIENT /debug:partial No replacement /architecture: use /arch: /Fm use /map /help, /? [category] print full or category help message Valid categories include advanced - Advanced Optimizations codegen - Code Generation compatibility - Compatibility component - Component Control data - Data deprecated - Deprecated Options diagnostics - Compiler Diagnostics float - Floating Point help - Help inline - Inlining ipo - Interprocedural Optimization (IPO) language - Language link - Linking/Linker misc - Miscellaneous opt - Optimization output - Output pgo - Profile Guided Optimization (PGO) preproc - Preprocessor reports - Optimization Reports openmp - OpenMP and Parallel Processing Copyright (C) 1985-2018, Intel Corporation. All rights reserved. * Other names and brands may be claimed as the property of others. Trying FC compiler flag -PIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp -PIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/PIC' Successful compile: Source: program main end Rejecting compiler flag -PIC due to ifort: command line warning #10006: ignoring unknown option '/PIC' Rejected FC compiler flag -PIC because shared linker cannot handle it Trying FC compiler flag -fPIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp -fPIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/fPIC' Successful compile: Source: program main end Rejecting compiler flag -fPIC due to ifort: command line warning #10006: ignoring unknown option '/fPIC' Rejected FC compiler flag -fPIC because shared linker cannot handle it Trying FC compiler flag -KPIC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp -KPIC /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/KPIC' Successful compile: Source: program main end Rejecting compiler flag -KPIC due to ifort: command line warning #10006: ignoring unknown option '/KPIC' Rejected FC compiler flag -KPIC because shared linker cannot handle it Trying FC compiler flag -qpic Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp -qpic /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/qpic' Successful compile: Source: program main end Rejecting compiler flag -qpic due to ifort: command line warning #10006: ignoring unknown option '/qpic' Rejected FC compiler flag -qpic because shared linker cannot handle it Popping language FC ================================================================================ TEST checkSharedLinkerPaths from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1413) TESTING: checkSharedLinkerPaths from config.setCompilers(config/BuildSystem/config/setCompilers.py:1413) Determine the shared linker path options - IRIX: -rpath - Linux, OSF: -Wl,-rpath, - Solaris: -R - FreeBSD: -Wl,-R, Pushing language C Executing: uname -s stdout: CYGWIN_NT-6.1 Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -V stdout: icl: command line error: no files specified; for help type "icl /help" Trying C linker flag -Wl,-rpath, Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -Wl,-rpath,/home/alireza/petsc-3.9.3 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejecting C linker flag -Wl,-rpath,/home/alireza/petsc-3.9.3 due to icl: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejected C linker flag -Wl,-rpath, Trying C linker flag -R Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -R/home/alireza/petsc-3.9.3 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10006: ignoring unknown option '/R/home/alireza/petsc-3.9.3' Rejecting C linker flag -R/home/alireza/petsc-3.9.3 due to icl: command line warning #10006: ignoring unknown option '/R/home/alireza/petsc-3.9.3' Rejected C linker flag -R Trying C linker flag -rpath Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -rpath /home/alireza/petsc-3.9.3 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10006: ignoring unknown option '/rpath' icl: command line warning #10161: unrecognized source type 'E:\cygwin64\home\alireza\petsc-3.9.3'; object file assumed ipo: error #11018: Cannot open E:\cygwin64\home\alireza\petsc-3.9.3 LINK : fatal error LNK1104: cannot open file 'E:\cygwin64\home\alireza\petsc-3.9.3' Possible ERROR while running linker: exit code 20480 stdout: icl: command line warning #10006: ignoring unknown option '/rpath' icl: command line warning #10161: unrecognized source type 'E:\cygwin64\home\alireza\petsc-3.9.3'; object file assumed ipo: error #11018: Cannot open E:\cygwin64\home\alireza\petsc-3.9.3 LINK : fatal error LNK1104: cannot open file 'E:\cygwin64\home\alireza\petsc-3.9.3' Rejecting linker flag -rpath /home/alireza/petsc-3.9.3 due to nonzero status from link Rejecting C linker flag -rpath /home/alireza/petsc-3.9.3 due to icl: command line warning #10006: ignoring unknown option '/rpath' icl: command line warning #10161: unrecognized source type 'E:\cygwin64\home\alireza\petsc-3.9.3'; object file assumed ipo: error #11018: Cannot open E:\cygwin64\home\alireza\petsc-3.9.3 LINK : fatal error LNK1104: cannot open file 'E:\cygwin64\home\alireza\petsc-3.9.3' Rejected C linker flag -rpath Trying C linker flag -Wl,-R, Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -Wl,-R,/home/alireza/petsc-3.9.3 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejecting C linker flag -Wl,-R,/home/alireza/petsc-3.9.3 due to icl: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejected C linker flag -Wl,-R, Popping language C Pushing language Cxx Executing: uname -s stdout: CYGWIN_NT-6.1 Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -V stdout: icl: command line error: no files specified; for help type "icl /help" Trying Cxx linker flag -Wl,-rpath, Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -Wl,-rpath,/home/alireza/petsc-3.9.3 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejecting Cxx linker flag -Wl,-rpath,/home/alireza/petsc-3.9.3 due to icl: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejected Cxx linker flag -Wl,-rpath, Trying Cxx linker flag -R Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -R/home/alireza/petsc-3.9.3 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10006: ignoring unknown option '/R/home/alireza/petsc-3.9.3' Rejecting Cxx linker flag -R/home/alireza/petsc-3.9.3 due to icl: command line warning #10006: ignoring unknown option '/R/home/alireza/petsc-3.9.3' Rejected Cxx linker flag -R Trying Cxx linker flag -rpath Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -rpath /home/alireza/petsc-3.9.3 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10006: ignoring unknown option '/rpath' icl: command line warning #10161: unrecognized source type 'E:\cygwin64\home\alireza\petsc-3.9.3'; object file assumed ipo: error #11018: Cannot open E:\cygwin64\home\alireza\petsc-3.9.3 LINK : fatal error LNK1104: cannot open file 'E:\cygwin64\home\alireza\petsc-3.9.3' Possible ERROR while running linker: exit code 20480 stdout: icl: command line warning #10006: ignoring unknown option '/rpath' icl: command line warning #10161: unrecognized source type 'E:\cygwin64\home\alireza\petsc-3.9.3'; object file assumed ipo: error #11018: Cannot open E:\cygwin64\home\alireza\petsc-3.9.3 LINK : fatal error LNK1104: cannot open file 'E:\cygwin64\home\alireza\petsc-3.9.3' Rejecting linker flag -rpath /home/alireza/petsc-3.9.3 due to nonzero status from link Rejecting Cxx linker flag -rpath /home/alireza/petsc-3.9.3 due to icl: command line warning #10006: ignoring unknown option '/rpath' icl: command line warning #10161: unrecognized source type 'E:\cygwin64\home\alireza\petsc-3.9.3'; object file assumed ipo: error #11018: Cannot open E:\cygwin64\home\alireza\petsc-3.9.3 LINK : fatal error LNK1104: cannot open file 'E:\cygwin64\home\alireza\petsc-3.9.3' Rejected Cxx linker flag -rpath Trying Cxx linker flag -Wl,-R, Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -Wl,-R,/home/alireza/petsc-3.9.3 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: icl: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejecting Cxx linker flag -Wl,-R,/home/alireza/petsc-3.9.3 due to icl: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejected Cxx linker flag -Wl,-R, Popping language Cxx Pushing language FC Executing: uname -s stdout: CYGWIN_NT-6.1 Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -V stdout: icl: command line error: no files specified; for help type "icl /help" Trying FC linker flag -Wl,-rpath, Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -Wl,-rpath,/home/alireza/petsc-3.9.3 -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: ifort: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejecting FC linker flag -Wl,-rpath,/home/alireza/petsc-3.9.3 due to ifort: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejected FC linker flag -Wl,-rpath, Trying FC linker flag -R Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -R/home/alireza/petsc-3.9.3 -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: ifort: command line warning #10006: ignoring unknown option '/R/home/alireza/petsc-3.9.3' Rejecting FC linker flag -R/home/alireza/petsc-3.9.3 due to ifort: command line warning #10006: ignoring unknown option '/R/home/alireza/petsc-3.9.3' Rejected FC linker flag -R Trying FC linker flag -rpath Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -rpath /home/alireza/petsc-3.9.3 -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: ifort: command line warning #10006: ignoring unknown option '/rpath' ifort: command line warning #10161: unrecognized source type 'E:\cygwin64\home\alireza\petsc-3.9.3'; object file assumed ipo: error #11018: Cannot open E:\cygwin64\home\alireza\petsc-3.9.3 LINK : fatal error LNK1104: cannot open file 'E:\cygwin64\home\alireza\petsc-3.9.3' Possible ERROR while running linker: exit code 20480 stdout: ifort: command line warning #10006: ignoring unknown option '/rpath' ifort: command line warning #10161: unrecognized source type 'E:\cygwin64\home\alireza\petsc-3.9.3'; object file assumed ipo: error #11018: Cannot open E:\cygwin64\home\alireza\petsc-3.9.3 LINK : fatal error LNK1104: cannot open file 'E:\cygwin64\home\alireza\petsc-3.9.3' Rejecting linker flag -rpath /home/alireza/petsc-3.9.3 due to nonzero status from link Rejecting FC linker flag -rpath /home/alireza/petsc-3.9.3 due to ifort: command line warning #10006: ignoring unknown option '/rpath' ifort: command line warning #10161: unrecognized source type 'E:\cygwin64\home\alireza\petsc-3.9.3'; object file assumed ipo: error #11018: Cannot open E:\cygwin64\home\alireza\petsc-3.9.3 LINK : fatal error LNK1104: cannot open file 'E:\cygwin64\home\alireza\petsc-3.9.3' Rejected FC linker flag -rpath Trying FC linker flag -Wl,-R, Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.exe -Wl,-R,/home/alireza/petsc-3.9.3 -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o stdout: ifort: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejecting FC linker flag -Wl,-R,/home/alireza/petsc-3.9.3 due to ifort: command line warning #10157: ignoring option '/W'; argument is of wrong type Rejected FC linker flag -Wl,-R, Popping language FC ================================================================================ TEST checkLibC from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1448) TESTING: checkLibC from config.setCompilers(config/BuildSystem/config/setCompilers.py:1448) Test whether we need to explicitly include libc in shared linking - Mac OSX requires an explicit reference to libc for shared linking Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int foo(void) {void *chunk = malloc(31); free(chunk); return 0;} Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/libconftest.dll -LD -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o Shared linking does not require an explicit libc reference ================================================================================ TEST checkDynamicLinker from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1497) TESTING: checkDynamicLinker from config.setCompilers(config/BuildSystem/config/setCompilers.py:1497) Check that the linker can dynamicaly load shared libraries Checking for header: dlfcn.h All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "dlfcn.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "dlfcn.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: Dynamic loading disabled since dlfcn.h was missing ================================================================================ TEST output from config.setCompilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/setCompilers.py:1549) TESTING: output from config.setCompilers(config/BuildSystem/config/setCompilers.py:1549) Output module data as defines and substitutions Substituting "CC" with "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" Substituting "CFLAGS" with "-O2 -MT -wd4996 -Qopenmp " Defined make macro "CC_LINKER_SLFLAG" to "-L" Substituting "CPP" with "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E" Substituting "CPPFLAGS" with "" Substituting "CXX" with "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" Substituting "CXX_CXXFLAGS" with " " Substituting "CXXFLAGS" with "-O2 -MT -wd4996 -Qopenmp" Substituting "CXX_LINKER_SLFLAG" with "-L" Substituting "CXXCPP" with "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E" Substituting "CXXCPPFLAGS" with "" Substituting "FC" with "/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort" Substituting "FFLAGS" with "-MT -O2 -Qopenmp" Defined make macro "FC_LINKER_SLFLAG" to "-L" Substituting "LDFLAGS" with "" Substituting "LIBS" with "" Substituting "SHARED_LIBRARY_FLAG" with "-LD" Executing: uname -s stdout: CYGWIN_NT-6.1 Shared libraries (DLLs) - disabled due to fortran build on windows ================================================================================ TEST checkSharedDynamicPicOptions from PETSc.options.sharedLibraries(/home/alireza/petsc-3.9.3/config/PETSc/options/sharedLibraries.py:37) TESTING: checkSharedDynamicPicOptions from PETSc.options.sharedLibraries(config/PETSc/options/sharedLibraries.py:37) ================================================================================ TEST configureSharedLibraries from PETSc.options.sharedLibraries(/home/alireza/petsc-3.9.3/config/PETSc/options/sharedLibraries.py:53) TESTING: configureSharedLibraries from PETSc.options.sharedLibraries(config/PETSc/options/sharedLibraries.py:53) Checks whether shared libraries should be used, for which you must - Specify --with-shared-libraries - Have found a working shared linker Defines PETSC_USE_SHARED_LIBRARIES if they are used Defined make rule "shared_arch" with dependencies "" and code [] Defined make macro "BUILDSHAREDLIB" to "no" Defined "HAVE_SHARED_LIBRARIES" to "1" Shared libraries - disabled ================================================================================ TEST configureDynamicLibraries from PETSc.options.sharedLibraries(/home/alireza/petsc-3.9.3/config/PETSc/options/sharedLibraries.py:97) TESTING: configureDynamicLibraries from PETSc.options.sharedLibraries(config/PETSc/options/sharedLibraries.py:97) Checks whether dynamic loading is available (with dlfcn.h and libdl) ================================================================================ TEST configureSerializedFunctions from PETSc.options.sharedLibraries(/home/alireza/petsc-3.9.3/config/PETSc/options/sharedLibraries.py:103) TESTING: configureSerializedFunctions from PETSc.options.sharedLibraries(config/PETSc/options/sharedLibraries.py:103) Defines PETSC_SERIALIZE_FUNCTIONS if they are used Requires shared libraries ================================================================================ TEST configureIndexSize from PETSc.options.indexTypes(/home/alireza/petsc-3.9.3/config/PETSc/options/indexTypes.py:31) TESTING: configureIndexSize from PETSc.options.indexTypes(config/PETSc/options/indexTypes.py:31) Defined make macro "PETSC_INDEX_SIZE" to "32" ================================================================================ TEST configureCompilerFlags from config.compilerFlags(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilerFlags.py:72) TESTING: configureCompilerFlags from config.compilerFlags(config/BuildSystem/config/compilerFlags.py:72) Get the default compiler flags Ignoring default options which were overridden using --CFLAGS -O2 -MT -wd4996 -Qopenmp Optimization options found in CFLAGS. Skipping setting defaults Ignoring default options which were overridden using --CXXFLAGS -O2 -MT -wd4996 -Qopenmp Optimization options found in CXXFLAGS. Skipping setting defaults Ignoring default options which were overridden using --FFLAGS -MT -O2 -Qopenmp Optimization options found in FFLAGS. Skipping setting defaults Pushing language C Popping language C Pushing language Cxx Popping language Cxx Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl --version stdout: Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Intel(R) C++ Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 getCompilerVersion: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM \nIntel(R) C++ Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl --version stdout: Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Intel(R) C++ Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 getCompilerVersion: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM \nIntel(R) C++ Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort --version stdout: Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Intel(R) Visual Fortran Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 getCompilerVersion: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM \nIntel(R) Visual Fortran Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 ================================================================================ TEST configureDebugging from PETSc.options.debugging(/home/alireza/petsc-3.9.3/config/PETSc/options/debugging.py:25) TESTING: configureDebugging from PETSc.options.debugging(config/PETSc/options/debugging.py:25) Defined "USE_ERRORCHECKING" to "1" =============================================================================== WARNING! Compiling PETSc with no debugging, this should only be done for timing and production runs. All development should be done when configured using --with-debugging=1 =============================================================================== ================================================================================ TEST checkRestrict from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:139) TESTING: checkRestrict from config.compilers(config/BuildSystem/config/compilers.py:139) Check for the C/CXX restrict keyword Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -V stdout: icl: command line error: no files specified; for help type "icl /help" Pushing language C All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { float * __restrict x;; return 0; } compilers: Set C restrict keyword to __restrict Defined "C_RESTRICT" to "__restrict" Popping language C ================================================================================ TEST checkCFormatting from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:391) TESTING: checkCFormatting from config.compilers(config/BuildSystem/config/compilers.py:391) Activate format string checking if using the GNU compilers ================================================================================ TEST checkCStaticInline from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:109) TESTING: checkCStaticInline from config.compilers(config/BuildSystem/config/compilers.py:109) Check for C keyword: static inline Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" static inline int foo(int a) {return a;} int main() { foo(1);; return 0; } compilers: Set C StaticInline keyword to static inline Popping language C Defined "C_STATIC_INLINE" to "static inline" ================================================================================ TEST checkDynamicLoadFlag from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:402) TESTING: checkDynamicLoadFlag from config.compilers(config/BuildSystem/config/compilers.py:402) Checks that dlopen() takes RTLD_XXX, and defines PETSC_HAVE_RTLD_XXX if it does ================================================================================ TEST checkCLibraries from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:203) TESTING: checkCLibraries from config.compilers(config/BuildSystem/config/compilers.py:203) Determines the libraries needed to link with C compiled code Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include void asub(void) {char s[16];printf("testing %s",s);} Popping language C Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main print*,'testing' stop end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o Popping language FC C libraries are not needed when using Fortran linker Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include void asub(void) {char s[16];printf("testing %s",s);} Popping language C Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main(int argc,char **args) {return 0;} Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o Popping language Cxx C libraries are not needed when using C++ linker ================================================================================ TEST checkDependencyGenerationFlag from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1588) TESTING: checkDependencyGenerationFlag from config.compilers(config/BuildSystem/config/compilers.py:1588) Check if -MMD works for dependency generation, and add it if it does Trying C compiler flag -MMD -MP Rejected C compiler flag -MMD -MP Trying C compiler flag -MMD Rejected C compiler flag -MMD Trying C compiler flag -xMMD Rejected C compiler flag -xMMD Trying C compiler flag -qmakedep=gcc Rejected C compiler flag -qmakedep=gcc Trying C compiler flag -MD Rejected C compiler flag -MD because no dependency file (/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.d) was generated Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -MMD -MP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/MMD' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -MMD -MP due to icl: command line warning #10006: ignoring unknown option '/MMD' conftest.c Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -MMD /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/MMD' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -MMD due to icl: command line warning #10006: ignoring unknown option '/MMD' conftest.c Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -xMMD /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/xMMD' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -xMMD due to icl: command line warning #10006: ignoring unknown option '/xMMD' conftest.c Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -qmakedep=gcc /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/qmakedep=gcc' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -qmakedep=gcc due to icl: command line warning #10006: ignoring unknown option '/qmakedep=gcc' conftest.c Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -MD /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10121: overriding '/MT' with '/MD' conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Popping language C Trying Cxx compiler flag -MMD -MP Rejected Cxx compiler flag -MMD -MP Trying Cxx compiler flag -MMD Rejected Cxx compiler flag -MMD Trying Cxx compiler flag -xMMD Rejected Cxx compiler flag -xMMD Trying Cxx compiler flag -qmakedep=gcc Rejected Cxx compiler flag -qmakedep=gcc Trying Cxx compiler flag -MD Rejected Cxx compiler flag -MD because no dependency file (/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.d) was generated Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -MMD -MP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: icl: command line warning #10006: ignoring unknown option '/MMD' conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -MMD -MP due to icl: command line warning #10006: ignoring unknown option '/MMD' conftest.cc Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -MMD /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: icl: command line warning #10006: ignoring unknown option '/MMD' conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -MMD due to icl: command line warning #10006: ignoring unknown option '/MMD' conftest.cc Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -xMMD /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: icl: command line warning #10006: ignoring unknown option '/xMMD' conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -xMMD due to icl: command line warning #10006: ignoring unknown option '/xMMD' conftest.cc Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -qmakedep=gcc /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: icl: command line warning #10006: ignoring unknown option '/qmakedep=gcc' conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Rejecting compiler flag -qmakedep=gcc due to icl: command line warning #10006: ignoring unknown option '/qmakedep=gcc' conftest.cc Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -O2 -MT -wd4996 -Qopenmp -MD /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: icl: command line warning #10121: overriding '/MT' with '/MD' conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { ; return 0; } Popping language Cxx Trying FC compiler flag -MMD -MP Rejected FC compiler flag -MMD -MP Trying FC compiler flag -MMD Rejected FC compiler flag -MMD Trying FC compiler flag -xMMD Rejected FC compiler flag -xMMD Trying FC compiler flag -qmakedep=gcc Rejected FC compiler flag -qmakedep=gcc Trying FC compiler flag -MD Rejected FC compiler flag -MD because no dependency file (/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.d) was generated Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp -MMD -MP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/MMD' Successful compile: Source: program main end Rejecting compiler flag -MMD -MP due to ifort: command line warning #10006: ignoring unknown option '/MMD' Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp -MMD /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/MMD' Successful compile: Source: program main end Rejecting compiler flag -MMD due to ifort: command line warning #10006: ignoring unknown option '/MMD' Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp -xMMD /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/xMMD' Successful compile: Source: program main end Rejecting compiler flag -xMMD due to ifort: command line warning #10006: ignoring unknown option '/xMMD' Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp -qmakedep=gcc /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/qmakedep=gcc' Successful compile: Source: program main end Rejecting compiler flag -qmakedep=gcc due to ifort: command line warning #10006: ignoring unknown option '/qmakedep=gcc' Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -MT -O2 -Qopenmp -MD /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10121: overriding '/MT' with '/MD' Successful compile: Source: program main end Popping language FC ================================================================================ TEST checkC99Flag from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1634) TESTING: checkC99Flag from config.compilers(config/BuildSystem/config/compilers.py:1634) Check for -std=c99 or equivalent flag Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { float x[2],y; y = FLT_ROUNDS; // c++ comment int j = 2; for (int i=0; i<2; i++){ x[i] = i*j*y; } ; return 0; } Accepted C99 compile flag: Defined "HAVE_C99" to "1" Popping language C ================================================================================ TEST checkRestrict from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:139) TESTING: checkRestrict from config.compilers(config/BuildSystem/config/compilers.py:139) Check for the C/CXX restrict keyword Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -V stdout: icl: command line error: no files specified; for help type "icl /help" Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { float * __restrict x;; return 0; } compilers: Set Cxx restrict keyword to __restrict Defined "CXX_RESTRICT" to "__restrict" Popping language Cxx ================================================================================ TEST checkCxxNamespace from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:442) TESTING: checkCxxNamespace from config.compilers(config/BuildSystem/config/compilers.py:442) Checks that C++ compiler supports namespaces, and if it does defines HAVE_CXX_NAMESPACE Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" namespace petsc {int dummy;} int main() { ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" template struct a {}; namespace trouble{ template struct a : public ::a {}; } trouble::a uugh; int main() { ; return 0; } Popping language Cxx compilers: C++ has namespaces Defined "HAVE_CXX_NAMESPACE" to "1" ================================================================================ TEST checkCxxOptionalExtensions from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:415) TESTING: checkCxxOptionalExtensions from config.compilers(config/BuildSystem/config/compilers.py:415) Check whether the C++ compiler (IBM xlC, OSF5) need special flag for .c files which contain C++ Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: identifier "class" is undefined class somename { int i; };; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: expected a ";" class somename { int i; };; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: identifier "class" is undefined class somename { int i; };; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: expected a ";" class somename { int i; };; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" int main() { class somename { int i; };; return 0; } Rejecting compiler flag due to nonzero status from link Rejecting compiler flag due to conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: identifier "class" is undefined class somename { int i; };; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: expected a ";" class somename { int i; };; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c (code 2) PETSc Error: No output file produced Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -+ /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/+' conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: identifier "class" is undefined class somename { int i; };; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: expected a ";" class somename { int i; };; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: icl: command line warning #10006: ignoring unknown option '/+' conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: identifier "class" is undefined class somename { int i; };; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: expected a ";" class somename { int i; };; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" int main() { class somename { int i; };; return 0; } Rejecting compiler flag -+ due to nonzero status from link Rejecting compiler flag -+ due to icl: command line warning #10006: ignoring unknown option '/+' conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: identifier "class" is undefined class somename { int i; };; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: expected a ";" class somename { int i; };; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c (code 2) PETSc Error: No output file produced Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -x cxx -tlocal /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: Error: win32fe: Input File Not Found: E:\cygwin64\home\alireza\petsc-3.9.3\cxx Possible ERROR while running compiler: exit code 32512 stdout: Error: win32fe: Input File Not Found: E:\cygwin64\home\alireza\petsc-3.9.3\cxxSource: #include "confdefs.h" #include "conffix.h" int main() { class somename { int i; };; return 0; } Rejecting compiler flag -x cxx -tlocal due to nonzero status from link Rejecting compiler flag -x cxx -tlocal due to Error: win32fe: Input File Not Found: E:\cygwin64\home\alireza\petsc-3.9.3\cxx PETSc Error: No output file produced Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -Kc++ /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: icl: command line warning #10006: ignoring unknown option '/Kc++' conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: identifier "class" is undefined class somename { int i; };; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: expected a ";" class somename { int i; };; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: icl: command line warning #10006: ignoring unknown option '/Kc++' conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: identifier "class" is undefined class somename { int i; };; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: expected a ";" class somename { int i; };; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" int main() { class somename { int i; };; return 0; } Rejecting compiler flag -Kc++ due to nonzero status from link Rejecting compiler flag -Kc++ due to icl: command line warning #10006: ignoring unknown option '/Kc++' conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: identifier "class" is undefined class somename { int i; };; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c(5): error: expected a ";" class somename { int i; };; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.c (code 2) PETSc Error: No output file produced Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { class somename { int i; };; return 0; } Added Cxx compiler flag -TP Popping language Cxx ================================================================================ TEST checkCxxStaticInline from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:124) TESTING: checkCxxStaticInline from config.compilers(config/BuildSystem/config/compilers.py:124) Check for C++ keyword: static inline Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" static inline int foo(int a) {return a;} int main() { foo(1);; return 0; } compilers: Set Cxx StaticInline keyword to static inline Popping language Cxx Defined "CXX_STATIC_INLINE" to "static inline" ================================================================================ TEST checkCxxLibraries from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:500) TESTING: checkCxxLibraries from config.compilers(config/BuildSystem/config/compilers.py:500) Determines the libraries needed to link with C++ Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.cc stdout: conftest.cc C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.cc(7): warning #583: C++ exception handler found but /EHsc option was not specified try { throw 20; } catch (int e) { std::cout << "An exception occurred"; }} ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #include void asub(void) {std::vector v; try { throw 20; } catch (int e) { std::cout << "An exception occurred"; }} Popping language Cxx Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main(int argc,char **args) {return 0;} Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o Popping language C C++ libraries are not needed when using C linker Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.cc stdout: conftest.cc C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.cc(7): warning #583: C++ exception handler found but /EHsc option was not specified try { throw 20; } catch (int e) { std::cout << "An exception occurred"; }} ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #include void asub(void) {std::vector v; try { throw 20; } catch (int e) { std::cout << "An exception occurred"; }} Popping language Cxx Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main print*,'testing' stop end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o Popping language FC C++ libraries are not needed when using FC linker ================================================================================ TEST checkCxx11 from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:457) TESTING: checkCxx11 from config.compilers(config/BuildSystem/config/compilers.py:457) Determine the option needed to support the C++11 dialect We auto-detect C++11 if the compiler supports it without options, otherwise we require with-cxx-dialect=C++11 to try adding flags to support it. Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include template constexpr T Cubed( T x ) { return x*x*x; } int main() { std::random_device rd; std::mt19937 mt(rd()); std::normal_distribution dist(0,1); const double x = dist(mt); ; return 0; } Popping language Cxx ================================================================================ TEST checkFortranTypeSizes from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:713) TESTING: checkFortranTypeSizes from config.compilers(config/BuildSystem/config/compilers.py:713) Check whether real*8 is supported and suggest flags which will allow support Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main real*8 variable end Popping language FC ================================================================================ TEST checkFortranNameMangling from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:773) TESTING: checkFortranNameMangling from config.compilers(config/BuildSystem/config/compilers.py:773) Checks Fortran name mangling, and defines HAVE_FORTRAN_UNDERSCORE, HAVE_FORTRAN_NOUNDERSCORE, HAVE_FORTRAN_CAPS, or HAVE_FORTRAN_STDCALL Testing Fortran mangling type underscore with code void d1chk_(void){return;} Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" void d1chk_(void){return;} Popping language C Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main call d1chk() end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o stdout: conftest.obj : error LNK2019: unresolved external symbol D1CHK referenced in function MAIN__ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol D1CHK referenced in function MAIN__ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language FC Testing Fortran mangling type unchanged with code void d1chk(void){return;} Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" void d1chk(void){return;} Popping language C Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main call d1chk() end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o stdout: conftest.obj : error LNK2019: unresolved external symbol D1CHK referenced in function MAIN__ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol D1CHK referenced in function MAIN__ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language FC Testing Fortran mangling type caps with code void D1CHK(void){return;} Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" void D1CHK(void){return;} Popping language C Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main call d1chk() end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o Popping language FC compilers: Fortran name mangling is caps Defined "HAVE_FORTRAN_CAPS" to "1" Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort --version stdout: Win32 Development Tool Front End, version 1.11.3 Mon, Feb 27, 2017 11:10:38 AM Intel(R) Visual Fortran Intel(R) 64 Compiler for applications running on Intel(R) 64, Version 18.0.3.210 Build 20180410 Defined "FORTRAN_CHARLEN_T" to "int" ================================================================================ TEST checkFortranNameManglingDouble from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:814) TESTING: checkFortranNameManglingDouble from config.compilers(config/BuildSystem/config/compilers.py:814) Checks if symbols containing an underscore append an extra underscore, and defines HAVE_FORTRAN_UNDERSCORE_UNDERSCORE if necessary Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" void d1_chk__(void){return;} Popping language C Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main call d1_chk() end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o stdout: conftest.obj : error LNK2019: unresolved external symbol D1_CHK referenced in function MAIN__ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol D1_CHK referenced in function MAIN__ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language FC ================================================================================ TEST checkFortranPreprocessor from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:824) TESTING: checkFortranPreprocessor from config.compilers(config/BuildSystem/config/compilers.py:824) Determine if Fortran handles preprocessing properly compilers: Fortran uses CPP preprocessor Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1) Possible ERROR while running compiler: exit code 256 stdout: C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1)Source: program main #define dummy dummy #ifndef dummy fooey #endif end Rejecting compiler flag due to nonzero status from link Rejecting compiler flag due to C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1) PETSc Error: No output file produced Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -cpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/cpp' C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1) Possible ERROR while running compiler: exit code 256 stdout: ifort: command line warning #10006: ignoring unknown option '/cpp' C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1)Source: program main #define dummy dummy #ifndef dummy fooey #endif end Rejecting compiler flag -cpp due to nonzero status from link Rejecting compiler flag -cpp due to ifort: command line warning #10006: ignoring unknown option '/cpp' C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1) PETSc Error: No output file produced Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -xpp=cpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/xpp=cpp' C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1) Possible ERROR while running compiler: exit code 256 stdout: ifort: command line warning #10006: ignoring unknown option '/xpp=cpp' C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1)Source: program main #define dummy dummy #ifndef dummy fooey #endif end Rejecting compiler flag -xpp=cpp due to nonzero status from link Rejecting compiler flag -xpp=cpp due to ifort: command line warning #10006: ignoring unknown option '/xpp=cpp' C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1) PETSc Error: No output file produced Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -F /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line error: option '/F' is ambiguous Possible ERROR while running compiler: exit code 256 stdout: ifort: command line error: option '/F' is ambiguousSource: program main #define dummy dummy #ifndef dummy fooey #endif end Rejecting compiler flag -F due to nonzero status from link Rejecting compiler flag -F due to ifort: command line error: option '/F' is ambiguous PETSc Error: No output file produced Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -Cpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 stdout: ifort: command line warning #10006: ignoring unknown option '/Cpp' C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1) Possible ERROR while running compiler: exit code 256 stdout: ifort: command line warning #10006: ignoring unknown option '/Cpp' C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1)Source: program main #define dummy dummy #ifndef dummy fooey #endif end Rejecting compiler flag -Cpp due to nonzero status from link Rejecting compiler flag -Cpp due to ifort: command line warning #10006: ignoring unknown option '/Cpp' C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(2): warning #5117: Bad # preprocessor line #define dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(4): warning #5117: Bad # preprocessor line #ifndef dummy -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(3): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : dummy ----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(6): warning #5117: Bad # preprocessor line #endif -^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90(5): error #5082: Syntax error, found END-OF-STATEMENT when expecting one of: => = . [ % ( : fooey ------------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.setCompilers\conftest.F90 (code 1) PETSc Error: No output file produced Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main #define dummy dummy #ifndef dummy fooey #endif end Added FC compiler flag -fpp Popping language FC ================================================================================ TEST checkFortranDefineCompilerOption from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:848) TESTING: checkFortranDefineCompilerOption from config.compilers(config/BuildSystem/config/compilers.py:848) Check if -WF,-Dfoobar or -Dfoobar is the compiler option to define a macro Defined make macro "FC_DEFINE_FLAG" to "-D" compilers: Fortran uses -D for defining macro Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp -DTesting /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers/conftest.F90 Successful compile: Source: program main #define dummy dummy #ifndef Testing fooey #endif end Popping language FC ================================================================================ TEST checkFortranLibraries from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:868) TESTING: checkFortranLibraries from config.compilers(config/BuildSystem/config/compilers.py:868) Substitutes for FLIBS the libraries needed to link with Fortran This macro is intended to be used in those situations when it is necessary to mix, e.g. C++ and Fortran 77, source code into a single program or shared library. For example, if object files from a C++ and Fortran 77 compiler must be linked together, then the C++ compiler/linker must be used for linking (since special C++-ish things need to happen at link time like calling global constructors, instantiating templates, enabling exception support, etc.). However, the Fortran 77 intrinsic and run-time libraries must be linked in as well, but the C++ compiler/linker does not know how to add these Fortran 77 libraries. This code was translated from the autoconf macro which was packaged in its current form by Matthew D. Langston . However, nearly all of this macro came from the OCTAVE_FLIBS macro in octave-2.0.13/aclocal.m4, and full credit should go to John W. Eaton for writing this extremely useful macro. Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main #include call MPI_Allreduce() end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol MPI_ALLREDUCE referenced in function MAIN__ conftest.obj : error LNK2001: unresolved external symbol MPI_DUP_FN conftest.obj : error LNK2001: unresolved external symbol MPI_NULL_DELETE_FN conftest.obj : error LNK2001: unresolved external symbol MPI_NULL_COPY_FN conftest.obj : error LNK2001: unresolved external symbol MPI_COMM_DUP_FN conftest.obj : error LNK2001: unresolved external symbol MPI_COMM_NULL_DELETE_FN conftest.obj : error LNK2001: unresolved external symbol MPI_COMM_NULL_COPY_FN conftest.obj : error LNK2001: unresolved external symbol MPI_WIN_DUP_FN conftest.obj : error LNK2001: unresolved external symbol MPI_WIN_NULL_DELETE_FN conftest.obj : error LNK2001: unresolved external symbol MPI_WIN_NULL_COPY_FN conftest.obj : error LNK2001: unresolved external symbol MPI_TYPE_DUP_FN conftest.obj : error LNK2001: unresolved external symbol MPI_TYPE_NULL_DELETE_FN conftest.obj : error LNK2001: unresolved external symbol MPI_TYPE_NULL_COPY_FN conftest.obj : error LNK2001: unresolved external symbol MPI_CONVERSION_FN_NULL C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.exe : fatal error LNK1120: 14 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol MPI_ALLREDUCE referenced in function MAIN__ conftest.obj : error LNK2001: unresolved external symbol MPI_DUP_FN conftest.obj : error LNK2001: unresolved external symbol MPI_NULL_DELETE_FN conftest.obj : error LNK2001: unresolved external symbol MPI_NULL_COPY_FN conftest.obj : error LNK2001: unresolved external symbol MPI_COMM_DUP_FN conftest.obj : error LNK2001: unresolved external symbol MPI_COMM_NULL_DELETE_FN conftest.obj : error LNK2001: unresolved external symbol MPI_COMM_NULL_COPY_FN conftest.obj : error LNK2001: unresolved external symbol MPI_WIN_DUP_FN conftest.obj : error LNK2001: unresolved external symbol MPI_WIN_NULL_DELETE_FN conftest.obj : error LNK2001: unresolved external symbol MPI_WIN_NULL_COPY_FN conftest.obj : error LNK2001: unresolved external symbol MPI_TYPE_DUP_FN conftest.obj : error LNK2001: unresolved external symbol MPI_TYPE_NULL_DELETE_FN conftest.obj : error LNK2001: unresolved external symbol MPI_TYPE_NULL_COPY_FN conftest.obj : error LNK2001: unresolved external symbol MPI_CONVERSION_FN_NULL C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.exe : fatal error LNK1120: 14 unresolved externals Popping language FC Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: subroutine asub() print*,'testing' return end Popping language FC Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main(int argc,char **args) {return 0;} Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o Popping language C Fortran libraries are not needed when using C linker Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: subroutine asub() print*,'testing' return end Popping language FC Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main(int argc,char **args) {return 0;} Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o Popping language Cxx Fortran libraries are not needed when using C++ linker ================================================================================ TEST checkFortranLinkingCxx from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1263) TESTING: checkFortranLinkingCxx from config.compilers(config/BuildSystem/config/compilers.py:1263) Check that Fortran can be linked against C++ Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" extern "C" void D1CHK(void); void foo(void){D1CHK();} Popping language Cxx Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" extern "C" void D1CHK(void); void D1CHK(void){return;} Popping language Cxx Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main call d1chk() end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/cxxobj.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confc.o Popping language FC compilers: Fortran can link C++ functions ================================================================================ TEST checkFortran90 from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1329) TESTING: checkFortran90 from config.compilers(config/BuildSystem/config/compilers.py:1329) Determine whether the Fortran compiler handles F90 Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main INTEGER, PARAMETER :: int = SELECTED_INT_KIND(8) INTEGER (KIND=int) :: ierr ierr = 1 end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o Defined "USING_F90" to "1" Fortran compiler supports F90 Popping language FC ================================================================================ TEST checkFortran90FreeForm from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1342) TESTING: checkFortran90FreeForm from config.compilers(config/BuildSystem/config/compilers.py:1342) Determine whether the Fortran compiler handles F90FreeForm We also require that the compiler handles lines longer than 132 characters Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main INTEGER, PARAMETER :: int = SELECTED_INT_KIND(8); INTEGER (KIND=int) :: ierr; ierr = 1 end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o Defined "USING_F90FREEFORM" to "1" Fortran compiler supports F90FreeForm Popping language FC ================================================================================ TEST checkFortran2003 from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1356) TESTING: checkFortran2003 from config.compilers(config/BuildSystem/config/compilers.py:1356) Determine whether the Fortran compiler handles F2003 Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 stdout: C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(3): error #6218: This statement is positioned incorrectly and/or has syntax errors. module Base_module ------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(4): error #6848: This attribute specification is valid only in the specification part of a module. [PUBLIC] type, public :: base_type --------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(7): error #6850: This attribute specification is not valid in the main scoping unit. [PUBLIC] procedure, public :: Print => BasePrint ----------------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(7): error #8258: The procedure name in a type-bound procedure declaration should be the name of an accessible module procedure or an external procedure that has an explicit interface. [BASEPRINT] procedure, public :: Print => BasePrint -----------------------------------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(13): error #6790: This is an invalid statement; an END [PROGRAM] statement is required. end module Base_module ------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(13): error #6785: This name does not match the unit name. [BASE_MODULE] end module Base_module -----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(16): warning #5427: Program may contain only one main entry routine use,intrinsic :: iso_c_binding ------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90 (code 1) Possible ERROR while running compiler: exit code 256 stdout: C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(3): error #6218: This statement is positioned incorrectly and/or has syntax errors. module Base_module ------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(4): error #6848: This attribute specification is valid only in the specification part of a module. [PUBLIC] type, public :: base_type --------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(7): error #6850: This attribute specification is not valid in the main scoping unit. [PUBLIC] procedure, public :: Print => BasePrint ----------------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(7): error #8258: The procedure name in a type-bound procedure declaration should be the name of an accessible module procedure or an external procedure that has an explicit interface. [BASEPRINT] procedure, public :: Print => BasePrint -----------------------------------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(13): error #6790: This is an invalid statement; an END [PROGRAM] statement is required. end module Base_module ------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(13): error #6785: This name does not match the unit name. [BASE_MODULE] end module Base_module -----------------^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90(16): warning #5427: Program may contain only one main entry routine use,intrinsic :: iso_c_binding ------^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.compilers\conftest.F90 (code 1)Source: program main module Base_module type, public :: base_type integer :: A contains procedure, public :: Print => BasePrint end type base_type contains subroutine BasePrint(this) class(base_type) :: this end subroutine BasePrint end module Base_module use,intrinsic :: iso_c_binding Type(C_Ptr),Dimension(:),Pointer :: CArray character(kind=c_char),pointer :: nullc => null() character(kind=c_char,len=5),dimension(:),pointer::list1 allocate(list1(5)) CArray = (/(c_loc(list1(i)),i=1,5),c_loc(nullc)/) end Compile failed inside link Fortran compiler does not support F2003 Popping language FC ================================================================================ TEST checkFortran90Array from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1390) TESTING: checkFortran90Array from config.compilers(config/BuildSystem/config/compilers.py:1390) Check for F90 array interfaces Executing: uname -s stdout: CYGWIN_NT-6.1 Cygwin detected: ignoring HAVE_F90_2PTR_ARG test ================================================================================ TEST checkFortranModuleInclude from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1477) TESTING: checkFortranModuleInclude from config.compilers(config/BuildSystem/config/compilers.py:1477) Figures out what flag is used to specify the include path for Fortran modules Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: module configtest integer testint parameter (testint = 42) end module configtest Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confdir -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main use configtest write(*,*) testint end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confdir -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/configtest.o compilers: Fortran module include flag -I found Popping language FC ================================================================================ TEST checkFortranModuleOutput from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1543) TESTING: checkFortranModuleOutput from config.compilers(config/BuildSystem/config/compilers.py:1543) Figures out what flag is used to specify the include path for Fortran modules Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -module /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confdir -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Possible ERROR while running compiler: exit code 32512 Source: module configtest integer testint parameter (testint = 42) end module configtest compilers: Fortran module output flag -module compile failed Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -module:/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/confdir -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: module configtest integer testint parameter (testint = 42) end module configtest compilers: Fortran module output flag -module: found Popping language FC ================================================================================ TEST checkFortranTypeStar from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1318) TESTING: checkFortranTypeStar from config.compilers(config/BuildSystem/config/compilers.py:1318) Determine whether the Fortran compiler handles type(*) Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main interface subroutine a(b) type(*) :: b(:) end subroutine end interface end Defined "HAVE_FORTRAN_TYPE_STAR" to "1" Fortran compiler supports type(*) Popping language FC ================================================================================ TEST checkFortranTypeInitialize from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1307) TESTING: checkFortranTypeInitialize from config.compilers(config/BuildSystem/config/compilers.py:1307) Determines if PETSc objects in Fortran are initialized by default (doesn't work with common blocks) Defined "HAVE_FORTRAN_TYPE_INITIALIZE" to "0" Defined "FORTRAN_TYPE_INITIALIZE" to " = 0" Initializing Fortran objects ================================================================================ TEST configureFortranFlush from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1298) TESTING: configureFortranFlush from config.compilers(config/BuildSystem/config/compilers.py:1298) Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.F90 Successful compile: Source: program main call flush(6) end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.exe -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers/conftest.o Defined "HAVE_FORTRAN_FLUSH" to "1" Popping language FC ================================================================================ TEST setupFrameworkCompilers from config.compilers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/compilers.py:1710) TESTING: setupFrameworkCompilers from config.compilers(config/BuildSystem/config/compilers.py:1710) ================================================================================ TEST configureClosure from config.utilities.closure(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/closure.py:18) TESTING: configureClosure from config.utilities.closure(config/BuildSystem/config/utilities/closure.py:18) Determine if Apple ^close syntax is supported in C Pushing language C All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.closure\conftest.c(6): error: expected an identifier int (^closure)(int);; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.closure\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.closure\conftest.c(6): error: expected an identifier int (^closure)(int);; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.closure\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int (^closure)(int);; return 0; } Compile failed inside link ================================================================================ TEST configureFortranCPP from PETSc.options.fortranCPP(/home/alireza/petsc-3.9.3/config/PETSc/options/fortranCPP.py:21) TESTING: configureFortranCPP from PETSc.options.fortranCPP(config/PETSc/options/fortranCPP.py:21) Handle case where Fortran cannot preprocess properly Defined make rule ".f.o .f90.o .f95.o" with dependencies "" and code ['${PETSC_MAKE_STOP_ON_ERROR}${FC} -c ${FC_FLAGS} ${FFLAGS} -o $@ $<'] Defined make rule ".f.a" with dependencies "" and code ['${PETSC_MAKE_STOP_ON_ERROR}${FC} -c ${FC_FLAGS} ${FFLAGS} $<', '-${AR} ${AR_FLAGS} ${LIBNAME} $*.o', '-${RM} $*.o'] Defined make rule ".F.o .F90.o .F95.o" with dependencies "" and code ['${PETSC_MAKE_STOP_ON_ERROR}${FC} -c ${FC_FLAGS} ${FFLAGS} ${FCPPFLAGS} -o $@ $<'] Defined make rule ".F.a" with dependencies "" and code ['${PETSC_MAKE_STOP_ON_ERROR}${FC} -c ${FC_FLAGS} ${FFLAGS} ${FCPPFLAGS} $<', '-${AR} ${AR_FLAGS} ${LIBNAME} $*.o', '-${RM} $*.o'] ================================================================================ TEST checkStdC from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:105) TESTING: checkStdC from config.headers(config/BuildSystem/config/headers.py:105) Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #include #include #include int main() { ; return 0; } Source: #include "confdefs.h" #include "conffix.h" #include Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" #pragma once __pragma(pack(push, 8)) int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); unsigned long* __cdecl __doserrno(void); errno_t __cdecl _set_doserrno( unsigned long _Value); errno_t __cdecl _get_doserrno( unsigned long * _Value); #line 70 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" #line 79 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" #line 127 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" __pragma(pack(pop)) #line 12 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime_string.h" #pragma once __pragma(pack(push, 8)) void * __cdecl memchr( void const* _Buf, int _Val, size_t _MaxCount ); int __cdecl memcmp( void const* _Buf1, void const* _Buf2, size_t _Size ); void* __cdecl memcpy( void* _Dst, void const* _Src, size_t _Size ); void* __cdecl memmove( void* _Dst, void const* _Src, size_t _Size ); void* __cdecl memset( void* _Dst, int _Val, size_t _Size ); char * __cdecl strchr( char const* _Str, int _Val ); char * __cdecl strrchr( char const* _Str, int _Ch ); char * __cdecl strstr( char const* _Str, char const* _SubStr ); wchar_t * __cdecl wcschr( wchar_t const* _Str, wchar_t _Ch ); wchar_t * __cdecl wcsrchr( wchar_t const* _Str, wchar_t _Ch ); wchar_t * __cdecl wcsstr( wchar_t const* _Str, wchar_t const* _SubStr ); __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" static __inline errno_t __cdecl memcpy_s( void* const _Destination, rsize_t const _DestinationSize, void const* const _Source, rsize_t const _SourceSize ) { if (_SourceSize == 0) { return 0; } { int _Expr_val=!!(_Destination != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; if (_Source == ((void *)0) || _DestinationSize < _SourceSize) { memset(_Destination, 0, _DestinationSize); { int _Expr_val=!!(_Source != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; { int _Expr_val=!!(_DestinationSize >= _SourceSize); if (!(_Expr_val)) { (*_errno()) = 34; _invalid_parameter_noinfo(); return 34; } }; return 22; } memcpy(_Destination, _Source, _SourceSize); return 0; } static __inline errno_t __cdecl memmove_s( void* const _Destination, rsize_t const _DestinationSize, void const* const _Source, rsize_t const _SourceSize ) { if (_SourceSize == 0) { return 0; } { int _Expr_val=!!(_Destination != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; { int _Expr_val=!!(_Source != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; { int _Expr_val=!!(_DestinationSize >= _SourceSize); if (!(_Expr_val)) { (*_errno()) = 34; _invalid_parameter_noinfo(); return 34; } }; memmove(_Destination, _Source, _SourceSize); return 0; } __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" __pragma(pack(push, 8)) int __cdecl _memicmp( void const* _Buf1, void const* _Buf2, size_t _Size ); int __cdecl _memicmp_l( void const* _Buf1, void const* _Buf2, size_t _Size, _locale_t _Locale ); #line 56 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" #line 71 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_memccpy" ". See online help for details.")) void* __cdecl memccpy( void* _Dst, void const* _Src, int _Val, size_t _Size ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_memicmp" ". See online help for details.")) int __cdecl memicmp( void const* _Buf1, void const* _Buf2, size_t _Size ); #line 111 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" #pragma once __pragma(pack(push, 8)) errno_t __cdecl wcscat_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source ); errno_t __cdecl wcscpy_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source ); errno_t __cdecl wcsncat_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source, rsize_t _MaxCount ); errno_t __cdecl wcsncpy_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source, rsize_t _MaxCount ); wchar_t* __cdecl wcstok_s( wchar_t* _String, wchar_t const* _Delimiter, wchar_t** _Context ); __declspec(allocator) wchar_t* __cdecl _wcsdup( wchar_t const* _String ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcscat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcscat( wchar_t *_Destination, wchar_t const* _Source); #pragma warning(pop) int __cdecl wcscmp( wchar_t const* _String1, wchar_t const* _String2 ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcscpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcscpy( wchar_t *_Destination, wchar_t const* _Source); #pragma warning(pop) size_t __cdecl wcscspn( wchar_t const* _String, wchar_t const* _Control ); size_t __cdecl wcslen( wchar_t const* _String ); size_t __cdecl wcsnlen( wchar_t const* _Source, size_t _MaxCount ); static __inline size_t __cdecl wcsnlen_s( wchar_t const* _Source, size_t _MaxCount ) { return (_Source == 0) ? 0 : wcsnlen(_Source, _MaxCount); } __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcsncat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcsncat( wchar_t *_Destination, wchar_t const* _Source, size_t _Count); int __cdecl wcsncmp( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcsncpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcsncpy( wchar_t *_Destination, wchar_t const* _Source, size_t _Count); wchar_t * __cdecl wcspbrk( wchar_t const* _String, wchar_t const* _Control ); size_t __cdecl wcsspn( wchar_t const* _String, wchar_t const* _Control ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstok_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcstok( wchar_t* _String, wchar_t const* _Delimiter, wchar_t** _Context ); #line 242 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" #pragma warning(push) #pragma warning(disable: 4141 4996) #pragma warning(disable: 28719 28726 28727) __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstok_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) static __inline wchar_t* __cdecl _wcstok( wchar_t* const _String, wchar_t const* const _Delimiter ) { return wcstok(_String, _Delimiter, 0); } #line 269 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" #pragma warning(pop) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcserror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcserror( int _ErrorNumber ); errno_t __cdecl _wcserror_s( wchar_t* _Buffer, size_t _SizeInWords, int _ErrorNumber ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "__wcserror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl __wcserror( wchar_t const* _String ); errno_t __cdecl __wcserror_s( wchar_t* _Buffer, size_t _SizeInWords, wchar_t const* _ErrorMessage ); int __cdecl _wcsicmp( wchar_t const* _String1, wchar_t const* _String2 ); int __cdecl _wcsicmp_l( wchar_t const* _String1, wchar_t const* _String2, _locale_t _Locale ); int __cdecl _wcsnicmp( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); int __cdecl _wcsnicmp_l( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount, _locale_t _Locale ); errno_t __cdecl _wcsnset_s( wchar_t* _Destination, size_t _SizeInWords, wchar_t _Value, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsnset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsnset( wchar_t *_String, wchar_t _Value, size_t _MaxCount); wchar_t* __cdecl _wcsrev( wchar_t* _String ); errno_t __cdecl _wcsset_s( wchar_t* _Destination, size_t _SizeInWords, wchar_t _Value ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsset( wchar_t *_String, wchar_t _Value); errno_t __cdecl _wcslwr_s( wchar_t* _String, size_t _SizeInWords ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcslwr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcslwr( wchar_t *_String); errno_t __cdecl _wcslwr_s_l( wchar_t* _String, size_t _SizeInWords, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcslwr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcslwr_l( wchar_t *_String, _locale_t _Locale); errno_t __cdecl _wcsupr_s( wchar_t* _String, size_t _Size ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsupr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsupr( wchar_t *_String); errno_t __cdecl _wcsupr_s_l( wchar_t* _String, size_t _Size, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsupr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsupr_l( wchar_t *_String, _locale_t _Locale); size_t __cdecl wcsxfrm( wchar_t* _Destination, wchar_t const* _Source, size_t _MaxCount ); size_t __cdecl _wcsxfrm_l( wchar_t* _Destination, wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale ); int __cdecl wcscoll( wchar_t const* _String1, wchar_t const* _String2 ); int __cdecl _wcscoll_l( wchar_t const* _String1, wchar_t const* _String2, _locale_t _Locale ); int __cdecl _wcsicoll( wchar_t const* _String1, wchar_t const* _String2 ); int __cdecl _wcsicoll_l( wchar_t const* _String1, wchar_t const* _String2, _locale_t _Locale ); int __cdecl _wcsncoll( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); int __cdecl _wcsncoll_l( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount, _locale_t _Locale ); int __cdecl _wcsnicoll( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); int __cdecl _wcsnicoll_l( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount, _locale_t _Locale ); #line 565 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsdup" ". See online help for details.")) wchar_t* __cdecl wcsdup( wchar_t const* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsicmp" ". See online help for details.")) int __cdecl wcsicmp( wchar_t const* _String1, wchar_t const* _String2 ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsnicmp" ". See online help for details.")) int __cdecl wcsnicmp( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsnset" ". See online help for details.")) wchar_t* __cdecl wcsnset( wchar_t* _String, wchar_t _Value, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsrev" ". See online help for details.")) wchar_t* __cdecl wcsrev( wchar_t* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsset" ". See online help for details.")) wchar_t* __cdecl wcsset( wchar_t* _String, wchar_t _Value ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcslwr" ". See online help for details.")) wchar_t* __cdecl wcslwr( wchar_t* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsupr" ". See online help for details.")) wchar_t* __cdecl wcsupr( wchar_t* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsicoll" ". See online help for details.")) int __cdecl wcsicoll( wchar_t const* _String1, wchar_t const* _String2 ); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" __pragma(pack(push, 8)) errno_t __cdecl strcpy_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source ); errno_t __cdecl strcat_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source ); errno_t __cdecl strerror_s( char* _Buffer, size_t _SizeInBytes, int _ErrorNumber); errno_t __cdecl strncat_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source, rsize_t _MaxCount ); errno_t __cdecl strncpy_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source, rsize_t _MaxCount ); char* __cdecl strtok_s( char* _String, char const* _Delimiter, char** _Context ); void* __cdecl _memccpy( void* _Dst, void const* _Src, int _Val, size_t _MaxCount ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "strcat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strcat( char *_Destination, char const* _Source); #pragma warning(pop) int __cdecl strcmp( char const* _Str1, char const* _Str2 ); int __cdecl _strcmpi( char const* _String1, char const* _String2 ); int __cdecl strcoll( char const* _String1, char const* _String2 ); int __cdecl _strcoll_l( char const* _String1, char const* _String2, _locale_t _Locale ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "strcpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strcpy( char *_Destination, char const* _Source); #pragma warning(pop) size_t __cdecl strcspn( char const* _Str, char const* _Control ); __declspec(allocator) char* __cdecl _strdup( char const* _Source ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strerror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strerror( char const* _ErrorMessage ); errno_t __cdecl _strerror_s( char* _Buffer, size_t _SizeInBytes, char const* _ErrorMessage ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strerror( int _ErrorMessage ); int __cdecl _stricmp( char const* _String1, char const* _String2 ); int __cdecl _stricoll( char const* _String1, char const* _String2 ); int __cdecl _stricoll_l( char const* _String1, char const* _String2, _locale_t _Locale ); int __cdecl _stricmp_l( char const* _String1, char const* _String2, _locale_t _Locale ); size_t __cdecl strlen( char const* _Str ); errno_t __cdecl _strlwr_s( char* _String, size_t _Size ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strlwr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strlwr( char *_String); errno_t __cdecl _strlwr_s_l( char* _String, size_t _Size, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strlwr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strlwr_l( char *_String, _locale_t _Locale); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strncat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strncat( char *_Destination, char const* _Source, size_t _Count); int __cdecl strncmp( char const* _Str1, char const* _Str2, size_t _MaxCount ); int __cdecl _strnicmp( char const* _String1, char const* _String2, size_t _MaxCount ); int __cdecl _strnicmp_l( char const* _String1, char const* _String2, size_t _MaxCount, _locale_t _Locale ); int __cdecl _strnicoll( char const* _String1, char const* _String2, size_t _MaxCount ); int __cdecl _strnicoll_l( char const* _String1, char const* _String2, size_t _MaxCount, _locale_t _Locale ); int __cdecl _strncoll( char const* _String1, char const* _String2, size_t _MaxCount ); int __cdecl _strncoll_l( char const* _String1, char const* _String2, size_t _MaxCount, _locale_t _Locale ); size_t __cdecl __strncnt( char const* _String, size_t _Count ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strncpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strncpy( char *_Destination, char const* _Source, size_t _Count); size_t __cdecl strnlen( char const* _String, size_t _MaxCount ); static __inline size_t __cdecl strnlen_s( char const* _String, size_t _MaxCount ) { return _String == 0 ? 0 : strnlen(_String, _MaxCount); } errno_t __cdecl _strnset_s( char* _String, size_t _SizeInBytes, int _Value, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strnset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strnset( char *_Destination, int _Value, size_t _Count); char * __cdecl strpbrk( char const* _Str, char const* _Control ); char* __cdecl _strrev( char* _Str ); errno_t __cdecl _strset_s( char* _Destination, size_t _DestinationSize, int _Value ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strset( char *_Destination, int _Value); size_t __cdecl strspn( char const* _Str, char const* _Control ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strtok_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strtok( char* _String, char const* _Delimiter ); errno_t __cdecl _strupr_s( char* _String, size_t _Size ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strupr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strupr( char *_String); errno_t __cdecl _strupr_s_l( char* _String, size_t _Size, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strupr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strupr_l( char *_String, _locale_t _Locale); size_t __cdecl strxfrm( char* _Destination, char const* _Source, size_t _MaxCount ); size_t __cdecl _strxfrm_l( char* _Destination, char const* _Source, size_t _MaxCount, _locale_t _Locale ); #line 528 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strdup" ". See online help for details.")) char* __cdecl strdup( char const* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strcmpi" ". See online help for details.")) int __cdecl strcmpi( char const* _String1, char const* _String2 ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_stricmp" ". See online help for details.")) int __cdecl stricmp( char const* _String1, char const* _String2 ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strlwr" ". See online help for details.")) char* __cdecl strlwr( char* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strnicmp" ". See online help for details.")) int __cdecl strnicmp( char const* _String1, char const* _String2, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strnset" ". See online help for details.")) char* __cdecl strnset( char* _String, int _Value, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strrev" ". See online help for details.")) char* __cdecl strrev( char* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strset" ". See online help for details.")) char* __cdecl strset( char* _String, int _Value); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strupr" ". See online help for details.")) char* __cdecl strupr( char* _String ); __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Source: #include "confdefs.h" #include "conffix.h" #include Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" #pragma once __pragma(pack(push, 8)) #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __declspec(allocator) __declspec(restrict) void* __cdecl _calloc_base( size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl calloc( size_t _Count, size_t _Size ); int __cdecl _callnewh( size_t _Size ); __declspec(allocator) void* __cdecl _expand( void* _Block, size_t _Size ); void __cdecl _free_base( void* _Block ); void __cdecl free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _malloc_base( size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl malloc( size_t _Size ); size_t __cdecl _msize_base( void* _Block ); size_t __cdecl _msize( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _realloc_base( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl realloc( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc_base( void* _Block, size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc( void* _Block, size_t _Count, size_t _Size ); void __cdecl _aligned_free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_malloc( size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_malloc( size_t _Size, size_t _Alignment, size_t _Offset ); size_t __cdecl _aligned_msize( void* _Block, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_realloc( void* _Block, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_realloc( void* _Block, size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment ); #line 225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __pragma(pack(push, 8)) typedef int (__cdecl* _CoreCrtSecureSearchSortCompareFunction)(void*, void const*, void const*); typedef int (__cdecl* _CoreCrtNonSecureSearchSortCompareFunction)(void const*, void const*); void* __cdecl bsearch_s( void const* _Key, void const* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void __cdecl qsort_s( void* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl bsearch( void const* _Key, void const* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void __cdecl qsort( void* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lfind_s( void const* _Key, void const* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lsearch_s( void const* _Key, void* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); #line 185 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lfind" ". See online help for details.")) void* __cdecl lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lsearch" ". See online help for details.")) void* __cdecl lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma once __pragma(pack(push, 8)) errno_t __cdecl _itow_s( int _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _itow(int _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ltow_s( long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ltow(long _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ultow_s( unsigned long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ultow(unsigned long _Value, wchar_t *_Buffer, int _Radix); double __cdecl wcstod( wchar_t const* _String, wchar_t** _EndPtr ); double __cdecl _wcstod_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); long __cdecl wcstol( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long __cdecl _wcstol_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl wcstoll( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long long __cdecl _wcstoll_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl wcstoul( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long __cdecl _wcstoul_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl wcstoull( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long long __cdecl _wcstoull_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long double __cdecl wcstold( wchar_t const* _String, wchar_t** _EndPtr ); long double __cdecl _wcstold_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); float __cdecl wcstof( wchar_t const* _String, wchar_t** _EndPtr ); float __cdecl _wcstof_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); double __cdecl _wtof( wchar_t const* _String ); double __cdecl _wtof_l( wchar_t const* _String, _locale_t _Locale ); int __cdecl _wtoi( wchar_t const* _String ); int __cdecl _wtoi_l( wchar_t const* _String, _locale_t _Locale ); long __cdecl _wtol( wchar_t const* _String ); long __cdecl _wtol_l( wchar_t const* _String, _locale_t _Locale ); long long __cdecl _wtoll( wchar_t const* _String ); long long __cdecl _wtoll_l( wchar_t const* _String, _locale_t _Locale ); errno_t __cdecl _i64tow_s( __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _i64tow( __int64 _Value, wchar_t* _Buffer, int _Radix ); errno_t __cdecl _ui64tow_s( unsigned __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ui64tow( unsigned __int64 _Value, wchar_t* _Buffer, int _Radix ); __int64 __cdecl _wtoi64( wchar_t const* _String ); __int64 __cdecl _wtoi64_l( wchar_t const* _String, _locale_t _Locale ); __int64 __cdecl _wcstoi64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); __int64 __cdecl _wcstoi64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _wcstoui64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned __int64 __cdecl _wcstoui64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); __declspec(allocator) wchar_t* __cdecl _wfullpath( wchar_t* _Buffer, wchar_t const* _Path, size_t _BufferCount ); errno_t __cdecl _wmakepath_s( wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext ); #line 361 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wmakepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wmakepath( wchar_t *_Buffer, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext); #pragma warning(pop) void __cdecl _wperror( wchar_t const* _ErrorMessage ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsplitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsplitpath( wchar_t const* _FullPath, wchar_t* _Drive, wchar_t* _Dir, wchar_t* _Filename, wchar_t* _Ext ); errno_t __cdecl _wsplitpath_s( wchar_t const* _FullPath, wchar_t* _Drive, size_t _DriveCount, wchar_t* _Dir, size_t _DirCount, wchar_t* _Filename, size_t _FilenameCount, wchar_t* _Ext, size_t _ExtCount ); errno_t __cdecl _wdupenv_s( wchar_t** _Buffer, size_t* _BufferCount, wchar_t const* _VarName ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wdupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wgetenv( wchar_t const* _VarName ); errno_t __cdecl _wgetenv_s( size_t* _RequiredCount, wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _VarName ); #line 438 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" int __cdecl _wputenv( wchar_t const* _EnvString ); errno_t __cdecl _wputenv_s( wchar_t const* _Name, wchar_t const* _Value ); errno_t __cdecl _wsearchenv_s( wchar_t const* _Filename, wchar_t const* _VarName, wchar_t* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsearchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsearchenv(wchar_t const* _Filename, wchar_t const* _VarName, wchar_t *_ResultPath); int __cdecl _wsystem( wchar_t const* _Command ); __pragma(pack(pop)) #line 16 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #pragma once __pragma(pack(push, 8)) #line 29 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 43 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 71 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 79 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" __pragma(pack(pop)) #line 17 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __pragma(pack(push, 8)) void __cdecl _swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(noreturn) void __cdecl exit( int _Code); __declspec(noreturn) void __cdecl _exit( int _Code); __declspec(noreturn) void __cdecl _Exit( int _Code); __declspec(noreturn) void __cdecl quick_exit( int _Code); __declspec(noreturn) void __cdecl abort(void); unsigned int __cdecl _set_abort_behavior( unsigned int _Flags, unsigned int _Mask ); typedef int (__cdecl* _onexit_t)(void); #line 117 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 140 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl atexit(void (__cdecl*)(void)); _onexit_t __cdecl _onexit( _onexit_t _Func); int __cdecl at_quick_exit(void (__cdecl*)(void)); typedef void (__cdecl* _purecall_handler)(void); typedef void (__cdecl* _invalid_parameter_handler)( wchar_t const*, wchar_t const*, wchar_t const*, unsigned int, uintptr_t ); _purecall_handler __cdecl _set_purecall_handler( _purecall_handler _Handler ); _purecall_handler __cdecl _get_purecall_handler(void); _invalid_parameter_handler __cdecl _set_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_invalid_parameter_handler(void); _invalid_parameter_handler __cdecl _set_thread_local_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_thread_local_invalid_parameter_handler(void); #line 199 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl _set_error_mode( int _Mode); int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); unsigned long* __cdecl __doserrno(void); errno_t __cdecl _set_doserrno( unsigned long _Value); errno_t __cdecl _get_doserrno( unsigned long * _Value); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __sys_errlist(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int * __cdecl __sys_nerr(void); void __cdecl perror( char const* _ErrMsg); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_pgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __p__pgmptr (void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_wpgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t** __cdecl __p__wpgmptr(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_fmode" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int* __cdecl __p__fmode (void); #line 253 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" errno_t __cdecl _get_pgmptr ( char** _Value); errno_t __cdecl _get_wpgmptr( wchar_t** _Value); errno_t __cdecl _set_fmode ( int _Mode ); errno_t __cdecl _get_fmode ( int* _PMode); typedef struct _div_t { int quot; int rem; } div_t; typedef struct _ldiv_t { long quot; long rem; } ldiv_t; typedef struct _lldiv_t { long long quot; long long rem; } lldiv_t; int __cdecl abs ( int _Number); long __cdecl labs ( long _Number); long long __cdecl llabs ( long long _Number); __int64 __cdecl _abs64( __int64 _Number); unsigned short __cdecl _byteswap_ushort( unsigned short _Number); unsigned long __cdecl _byteswap_ulong ( unsigned long _Number); unsigned __int64 __cdecl _byteswap_uint64( unsigned __int64 _Number); div_t __cdecl div ( int _Numerator, int _Denominator); ldiv_t __cdecl ldiv ( long _Numerator, long _Denominator); lldiv_t __cdecl lldiv( long long _Numerator, long long _Denominator); #pragma warning (push) #pragma warning (disable:6540) unsigned int __cdecl _rotl( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotl( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotl64( unsigned __int64 _Value, int _Shift ); unsigned int __cdecl _rotr( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotr( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotr64( unsigned __int64 _Value, int _Shift ); #pragma warning (pop) void __cdecl srand( unsigned int _Seed); int __cdecl rand(void); #line 380 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma pack(push, 4) typedef struct { unsigned char ld[10]; } _LDOUBLE; #pragma pack(pop) #line 410 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" typedef struct { double x; } _CRT_DOUBLE; typedef struct { float f; } _CRT_FLOAT; typedef struct { long double x; } _LONGDOUBLE; #pragma pack(push, 4) typedef struct { unsigned char ld12[12]; } _LDBL12; #pragma pack(pop) double __cdecl atof ( char const* _String); int __cdecl atoi ( char const* _String); long __cdecl atol ( char const* _String); long long __cdecl atoll ( char const* _String); __int64 __cdecl _atoi64( char const* _String); double __cdecl _atof_l ( char const* _String, _locale_t _Locale); int __cdecl _atoi_l ( char const* _String, _locale_t _Locale); long __cdecl _atol_l ( char const* _String, _locale_t _Locale); long long __cdecl _atoll_l ( char const* _String, _locale_t _Locale); __int64 __cdecl _atoi64_l( char const* _String, _locale_t _Locale); int __cdecl _atoflt ( _CRT_FLOAT* _Result, char const* _String); int __cdecl _atodbl ( _CRT_DOUBLE* _Result, char* _String); int __cdecl _atoldbl( _LDOUBLE* _Result, char* _String); int __cdecl _atoflt_l( _CRT_FLOAT* _Result, char const* _String, _locale_t _Locale ); int __cdecl _atodbl_l( _CRT_DOUBLE* _Result, char* _String, _locale_t _Locale ); int __cdecl _atoldbl_l( _LDOUBLE* _Result, char* _String, _locale_t _Locale ); float __cdecl strtof( char const* _String, char** _EndPtr ); float __cdecl _strtof_l( char const* _String, char** _EndPtr, _locale_t _Locale ); double __cdecl strtod( char const* _String, char** _EndPtr ); double __cdecl _strtod_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long double __cdecl strtold( char const* _String, char** _EndPtr ); long double __cdecl _strtold_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long __cdecl strtol( char const* _String, char** _EndPtr, int _Radix ); long __cdecl _strtol_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl strtoll( char const* _String, char** _EndPtr, int _Radix ); long long __cdecl _strtoll_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl strtoul( char const* _String, char** _EndPtr, int _Radix ); unsigned long __cdecl _strtoul_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl strtoull( char const* _String, char** _EndPtr, int _Radix ); unsigned long long __cdecl _strtoull_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); __int64 __cdecl _strtoi64( char const* _String, char** _EndPtr, int _Radix ); __int64 __cdecl _strtoi64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _strtoui64( char const* _String, char** _EndPtr, int _Radix ); unsigned __int64 __cdecl _strtoui64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); errno_t __cdecl _itoa_s( int _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _itoa(int _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _ltoa_s( long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ltoa(long _Value, char *_Buffer, int _Radix); errno_t __cdecl _ultoa_s( unsigned long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ultoa(unsigned long _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _i64toa_s( __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _i64toa( __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ui64toa_s( unsigned __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ui64toa( unsigned __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ecvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _fcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _gcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _gcvt( double _Value, int _DigitCount, char* _Buffer ); #line 838 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl ___mb_cur_max_func(void); int __cdecl ___mb_cur_max_l_func(_locale_t _Locale); int __cdecl mblen( char const* _Ch, size_t _MaxCount ); int __cdecl _mblen_l( char const* _Ch, size_t _MaxCount, _locale_t _Locale ); size_t __cdecl _mbstrlen( char const* _String ); size_t __cdecl _mbstrlen_l( char const* _String, _locale_t _Locale ); size_t __cdecl _mbstrnlen( char const* _String, size_t _MaxCount ); size_t __cdecl _mbstrnlen_l( char const* _String, size_t _MaxCount, _locale_t _Locale ); int __cdecl mbtowc( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes ); int __cdecl _mbtowc_l( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes, _locale_t _Locale ); errno_t __cdecl mbstowcs_s( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "mbstowcs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl mbstowcs( wchar_t *_Dest, char const* _Source, size_t _MaxCount); errno_t __cdecl _mbstowcs_s_l( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_mbstowcs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _mbstowcs_l( wchar_t *_Dest, char const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wctomb_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl wctomb( char* _MbCh, wchar_t _WCh ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctomb_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _wctomb_l( char* _MbCh, wchar_t _WCh, _locale_t _Locale ); errno_t __cdecl wctomb_s( int* _SizeConverted, char* _MbCh, rsize_t _SizeInBytes, wchar_t _WCh ); errno_t __cdecl _wctomb_s_l( int* _SizeConverted, char* _MbCh, size_t _SizeInBytes, wchar_t _WCh, _locale_t _Locale); errno_t __cdecl wcstombs_s( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstombs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl wcstombs( char *_Dest, wchar_t const* _Source, size_t _MaxCount); errno_t __cdecl _wcstombs_s_l( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcstombs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _wcstombs_l( char *_Dest, wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(allocator) char* __cdecl _fullpath( char* _Buffer, char const* _Path, size_t _BufferCount ); errno_t __cdecl _makepath_s( char* _Buffer, size_t _BufferCount, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_makepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _makepath( char *_Buffer, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext); #pragma warning(pop) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_splitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _splitpath( char const* _FullPath, char* _Drive, char* _Dir, char* _Filename, char* _Ext ); errno_t __cdecl _splitpath_s( char const* _FullPath, char* _Drive, size_t _DriveCount, char* _Dir, size_t _DirCount, char* _Filename, size_t _FilenameCount, char* _Ext, size_t _ExtCount ); errno_t __cdecl getenv_s( size_t* _RequiredCount, char* _Buffer, rsize_t _BufferCount, char const* _VarName ); int* __cdecl __p___argc (void); char*** __cdecl __p___argv (void); wchar_t*** __cdecl __p___wargv(void); #line 1164 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" char*** __cdecl __p__environ (void); wchar_t*** __cdecl __p__wenviron(void); #line 1181 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "_dupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl getenv( char const* _VarName ); errno_t __cdecl _dupenv_s( char** _Buffer, size_t* _BufferCount, char const* _VarName ); int __cdecl system( char const* _Command ); #pragma warning (push) #pragma warning (disable:6540) int __cdecl _putenv( char const* _EnvString ); errno_t __cdecl _putenv_s( char const* _Name, char const* _Value ); #pragma warning (pop) errno_t __cdecl _searchenv_s( char const* _Filename, char const* _VarName, char* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_searchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _searchenv(char const* _Filename, char const* _VarName, char *_Buffer); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "SetErrorMode" " " "instead. See online help for details.")) void __cdecl _seterrormode( int _Mode ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Beep" " " "instead. See online help for details.")) void __cdecl _beep( unsigned _Frequency, unsigned _Duration ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Sleep" " " "instead. See online help for details.")) void __cdecl _sleep( unsigned long _Duration ); #pragma warning(push) #pragma warning(disable: 4141) __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ecvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_fcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_gcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl gcvt( double _Value, int _DigitCount, char* _DstBuf ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_itoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl itoa( int _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ltoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ltoa( long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_swab" ". See online help for details.")) void __cdecl swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ultoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ultoa( unsigned long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_putenv" ". See online help for details.")) int __cdecl putenv( char const* _EnvString ); #pragma warning(pop) _onexit_t __cdecl onexit( _onexit_t _Func); __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #include #define ISLOWER(c) ('a' <= (c) && (c) <= 'z') #define TOUPPER(c) (ISLOWER(c) ? 'A' + ((c) - 'a') : (c)) #define XOR(e, f) (((e) && !(f)) || (!(e) && (f))) int main() { int i; for(i = 0; i < 256; i++) if (XOR(islower(i), ISLOWER(i)) || toupper(i) != TOUPPER(i)) exit(2); exit(0); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.exe Defined "STDC_HEADERS" to "1" ================================================================================ TEST checkStat from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:138) TESTING: checkStat from config.headers(config/BuildSystem/config/headers.py:138) Checks whether stat file-mode macros are broken, and defines STAT_MACROS_BROKEN if they are Source: #include "confdefs.h" #include "conffix.h" #include #include #if defined(S_ISBLK) && defined(S_IFDIR) # if S_ISBLK (S_IFDIR) You lose. # endif #endif #if defined(S_ISBLK) && defined(S_IFCHR) # if S_ISBLK (S_IFCHR) You lose. # endif #endif #if defined(S_ISLNK) && defined(S_IFREG) # if S_ISLNK (S_IFREG) You lose. # endif #endif #if defined(S_ISSOCK) && defined(S_IFREG) # if S_ISSOCK (S_IFREG) You lose. # endif #endif Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\sys/types.h" #pragma once typedef unsigned short _ino_t; typedef _ino_t ino_t; typedef unsigned int _dev_t; typedef _dev_t dev_t; typedef long _off_t; typedef _off_t off_t; #line 5 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\sys/stat.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\sys/stat.h" __pragma(pack(push, 8)) #pragma warning(push) #pragma warning(disable: 4820) struct _stat32 { _dev_t st_dev; _ino_t st_ino; unsigned short st_mode; short st_nlink; short st_uid; short st_gid; _dev_t st_rdev; _off_t st_size; __time32_t st_atime; __time32_t st_mtime; __time32_t st_ctime; }; struct _stat32i64 { _dev_t st_dev; _ino_t st_ino; unsigned short st_mode; short st_nlink; short st_uid; short st_gid; _dev_t st_rdev; __int64 st_size; __time32_t st_atime; __time32_t st_mtime; __time32_t st_ctime; }; struct _stat64i32 { _dev_t st_dev; _ino_t st_ino; unsigned short st_mode; short st_nlink; short st_uid; short st_gid; _dev_t st_rdev; _off_t st_size; __time64_t st_atime; __time64_t st_mtime; __time64_t st_ctime; }; struct _stat64 { _dev_t st_dev; _ino_t st_ino; unsigned short st_mode; short st_nlink; short st_uid; short st_gid; _dev_t st_rdev; __int64 st_size; __time64_t st_atime; __time64_t st_mtime; __time64_t st_ctime; }; struct stat { _dev_t st_dev; _ino_t st_ino; unsigned short st_mode; short st_nlink; short st_uid; short st_gid; _dev_t st_rdev; _off_t st_size; time_t st_atime; time_t st_mtime; time_t st_ctime; }; #line 119 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\sys/stat.h" #line 129 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\sys/stat.h" #line 152 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\sys/stat.h" int __cdecl _fstat32( int _FileHandle, struct _stat32* _Stat ); int __cdecl _fstat32i64( int _FileHandle, struct _stat32i64* _Stat ); int __cdecl _fstat64i32( int _FileHandle, struct _stat64i32* _Stat ); int __cdecl _fstat64( int _FileHandle, struct _stat64* _Stat ); int __cdecl _stat32( char const* _FileName, struct _stat32* _Stat ); int __cdecl _stat32i64( char const* _FileName, struct _stat32i64* _Stat ); int __cdecl _stat64i32( char const* _FileName, struct _stat64i32* _Stat ); int __cdecl _stat64( char const* _FileName, struct _stat64* _Stat ); int __cdecl _wstat32( wchar_t const* _FileName, struct _stat32* _Stat ); int __cdecl _wstat32i64( wchar_t const* _FileName, struct _stat32i64* _Stat ); int __cdecl _wstat64i32( wchar_t const* _FileName, struct _stat64i32* _Stat ); int __cdecl _wstat64( wchar_t const* _FileName, struct _stat64* _Stat ); #line 233 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\sys/stat.h" static __inline int __cdecl fstat(int const _FileHandle, struct stat* const _Stat) { typedef char __static_assert_t[(sizeof(struct stat) == sizeof(struct _stat64i32)) != 0]; return _fstat64i32(_FileHandle, (struct _stat64i32*)_Stat); } static __inline int __cdecl stat(char const* const _FileName, struct stat* const _Stat) { typedef char __static_assert_t[(sizeof(struct stat) == sizeof(struct _stat64i32)) != 0]; return _stat64i32(_FileName, (struct _stat64i32*)_Stat); } #pragma warning(pop) __pragma(pack(pop)) #line 6 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" ================================================================================ TEST checkSysWait from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:173) TESTING: checkSysWait from config.headers(config/BuildSystem/config/headers.py:173) Check for POSIX.1 compatible sys/wait.h, and defines HAVE_SYS_WAIT_H if found Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(5): catastrophic error: cannot open source file "sys/wait.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c (code 4) Possible ERROR while running compiler: exit code 1024 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(5): catastrophic error: cannot open source file "sys/wait.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c (code 4)Source: #include "confdefs.h" #include "conffix.h" #include #include #ifndef WEXITSTATUS #define WEXITSTATUS(stat_val) ((unsigned)(stat_val) >> 8) #endif #ifndef WIFEXITED #define WIFEXITED(stat_val) (((stat_val) & 255) == 0) #endif int main() { int s; wait (&s); s = WIFEXITED (s) ? WEXITSTATUS (s) : 1; ; return 0; } ================================================================================ TEST checkTime from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:195) TESTING: checkTime from config.headers(config/BuildSystem/config/headers.py:195) Checks if you can safely include both and , and if so defines TIME_WITH_SYS_TIME Checking for header: time.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\time.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\time.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wtime.h" #pragma once __pragma(pack(push, 8)) struct tm { int tm_sec; int tm_min; int tm_hour; int tm_mday; int tm_mon; int tm_year; int tm_wday; int tm_yday; int tm_isdst; }; __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wasctime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wasctime( struct tm const* _Tm ); errno_t __cdecl _wasctime_s( wchar_t* _Buffer, size_t _SizeInWords, struct tm const* _Tm ); size_t __cdecl wcsftime( wchar_t* _Buffer, size_t _SizeInWords, wchar_t const* _Format, struct tm const* _Tm ); size_t __cdecl _wcsftime_l( wchar_t* _Buffer, size_t _SizeInWords, wchar_t const* _Format, struct tm const* _Tm, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctime32_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wctime32( __time32_t const* _Time ); errno_t __cdecl _wctime32_s( wchar_t* _Buffer, size_t _SizeInWords, __time32_t const* _Time ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctime64_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wctime64( __time64_t const* _Time ); errno_t __cdecl _wctime64_s( wchar_t* _Buffer, size_t _SizeInWords, __time64_t const* _Time); errno_t __cdecl _wstrdate_s( wchar_t* _Buffer, size_t _SizeInWords ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wstrdate_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wstrdate( wchar_t *_Buffer); errno_t __cdecl _wstrtime_s( wchar_t* _Buffer, size_t _SizeInWords ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wstrtime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wstrtime( wchar_t *_Buffer); #pragma warning(push) #pragma warning(disable: 4996) #line 183 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wtime.h" static __inline wchar_t * __cdecl _wctime( time_t const* const _Time) { return _wctime64(_Time); } static __inline errno_t __cdecl _wctime_s( wchar_t* const _Buffer, size_t const _SizeInWords, time_t const* const _Time ) { return _wctime64_s(_Buffer, _SizeInWords, _Time); } #pragma warning(pop) __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\time.h" __pragma(pack(push, 8)) typedef long clock_t; struct _timespec32 { __time32_t tv_sec; long tv_nsec; }; struct _timespec64 { __time64_t tv_sec; long tv_nsec; }; struct timespec { time_t tv_sec; long tv_nsec; }; __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_daylight" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int* __cdecl __daylight(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_dstbias" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) long* __cdecl __dstbias(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_timezone" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) long* __cdecl __timezone(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_tzname" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __tzname(void); errno_t __cdecl _get_daylight( int* _Daylight ); errno_t __cdecl _get_dstbias( long* _DaylightSavingsBias ); errno_t __cdecl _get_timezone( long* _TimeZone ); errno_t __cdecl _get_tzname( size_t* _ReturnValue, char* _Buffer, size_t _SizeInBytes, int _Index ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "asctime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl asctime( struct tm const* _Tm ); errno_t __cdecl asctime_s( char* _Buffer, size_t _SizeInBytes, struct tm const* _Tm ); clock_t __cdecl clock(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ctime32_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ctime32( __time32_t const* _Time ); errno_t __cdecl _ctime32_s( char* _Buffer, size_t _SizeInBytes, __time32_t const* _Time ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ctime64_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ctime64( __time64_t const* _Time ); errno_t __cdecl _ctime64_s( char* _Buffer, size_t _SizeInBytes, __time64_t const* _Time ); double __cdecl _difftime32( __time32_t _Time1, __time32_t _Time2 ); double __cdecl _difftime64( __time64_t _Time1, __time64_t _Time2 ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gmtime32_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) struct tm* __cdecl _gmtime32( __time32_t const* _Time ); errno_t __cdecl _gmtime32_s( struct tm* _Tm, __time32_t const* _Time ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gmtime64_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) struct tm* __cdecl _gmtime64( __time64_t const* _Time ); errno_t __cdecl _gmtime64_s( struct tm* _Tm, __time64_t const* _Time ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_localtime32_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) struct tm* __cdecl _localtime32( __time32_t const* _Time ); errno_t __cdecl _localtime32_s( struct tm* _Tm, __time32_t const* _Time ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_localtime64_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) struct tm* __cdecl _localtime64( __time64_t const* _Time ); errno_t __cdecl _localtime64_s( struct tm* _Tm, __time64_t const* _Time ); __time32_t __cdecl _mkgmtime32( struct tm* _Tm ); __time64_t __cdecl _mkgmtime64( struct tm* _Tm ); __time32_t __cdecl _mktime32( struct tm* _Tm ); __time64_t __cdecl _mktime64( struct tm* _Tm ); size_t __cdecl strftime( char* _Buffer, size_t _SizeInBytes, char const* _Format, struct tm const* _Tm ); size_t __cdecl _strftime_l( char* _Buffer, size_t _MaxSize, char const* _Format, struct tm const* _Tm, _locale_t _Locale ); errno_t __cdecl _strdate_s( char* _Buffer, size_t _SizeInBytes ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strdate_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strdate( char *_Buffer); errno_t __cdecl _strtime_s( char* _Buffer, size_t _SizeInBytes ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strtime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strtime( char *_Buffer); __time32_t __cdecl _time32( __time32_t* _Time ); __time64_t __cdecl _time64( __time64_t* _Time ); int __cdecl _timespec32_get( struct _timespec32* _Ts, int _Base ); int __cdecl _timespec64_get( struct _timespec64* _Ts, int _Base ); void __cdecl _tzset(void); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "GetLocalTime" " " "instead. See online help for details.")) unsigned __cdecl _getsystime( struct tm* _Tm ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "SetLocalTime" " " "instead. See online help for details.")) unsigned __cdecl _setsystime( struct tm* _Tm, unsigned _Milliseconds ); #line 474 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\time.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "ctime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) static __inline char* __cdecl ctime( time_t const* const _Time ) { #pragma warning(push) #pragma warning(disable: 4996) return _ctime64(_Time); #pragma warning(pop) } static __inline double __cdecl difftime( time_t const _Time1, time_t const _Time2 ) { return _difftime64(_Time1, _Time2); } __declspec(deprecated("This function or variable may be unsafe. Consider using " "gmtime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) static __inline struct tm* __cdecl gmtime( time_t const* const _Time) { #pragma warning(push) #pragma warning(disable: 4996) return _gmtime64(_Time); #pragma warning(pop) } __declspec(deprecated("This function or variable may be unsafe. Consider using " "localtime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) static __inline struct tm* __cdecl localtime( time_t const* const _Time ) { #pragma warning(push) #pragma warning(disable: 4996) return _localtime64(_Time); #pragma warning(pop) } static __inline time_t __cdecl _mkgmtime( struct tm* const _Tm ) { return _mkgmtime64(_Tm); } static __inline time_t __cdecl mktime( struct tm* const _Tm ) { return _mktime64(_Tm); } static __inline time_t __cdecl time( time_t* const _Time ) { return _time64(_Time); } static __inline int __cdecl timespec_get( struct timespec* const _Ts, int const _Base ) { return _timespec64_get((struct _timespec64*)_Ts, _Base); } static __inline errno_t __cdecl ctime_s( char* const _Buffer, size_t const _SizeInBytes, time_t const* const _Time ) { return _ctime64_s(_Buffer, _SizeInBytes, _Time); } static __inline errno_t __cdecl gmtime_s( struct tm* const _Tm, time_t const* const _Time ) { return _gmtime64_s(_Tm, _Time); } static __inline errno_t __cdecl localtime_s( struct tm* const _Tm, time_t const* const _Time ) { return _localtime64_s(_Tm, _Time); } __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_tzset" ". See online help for details.")) void __cdecl tzset(void); __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_TIME_H" to "1" Checking for header: sys/time.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/time.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/time.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(4): catastrophic error: cannot open source file "sys/time.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c (code 4) Possible ERROR while running compiler: exit code 1024 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(4): catastrophic error: cannot open source file "sys/time.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c (code 4)Source: #include "confdefs.h" #include "conffix.h" #include #include #include int main() { struct tm *tp = 0; if (tp); ; return 0; } ================================================================================ TEST checkMath from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:203) TESTING: checkMath from config.headers(config/BuildSystem/config/headers.py:203) Checks for the math headers and defines Checking for header: math.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 65 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 88 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 128 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" struct _complex { double x,y; } ; #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 65 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 88 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 128 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 137 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\math.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" __pragma(pack(push, 8)) #pragma warning(push) #pragma warning(disable:4738) #pragma warning(disable:4820) struct _exception { int type; char* name; double arg1; double arg2; double retval; }; #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" typedef float float_t; typedef double double_t; #line 74 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" extern double const _HUGE; void __cdecl _fperrraise( int _Except); short __cdecl _dclass( double _X); short __cdecl _ldclass( long double _X); short __cdecl _fdclass( float _X); int __cdecl _dsign( double _X); int __cdecl _ldsign( long double _X); int __cdecl _fdsign( float _X); int __cdecl _dpcomp( double _X, double _Y); int __cdecl _ldpcomp( long double _X, long double _Y); int __cdecl _fdpcomp( float _X, float _Y); short __cdecl _dtest( double* _Px); short __cdecl _ldtest( long double* _Px); short __cdecl _fdtest( float* _Px); short __cdecl _d_int( double* _Px, short _Xexp); short __cdecl _ld_int( long double* _Px, short _Xexp); short __cdecl _fd_int( float* _Px, short _Xexp); short __cdecl _dscale( double* _Px, long _Lexp); short __cdecl _ldscale( long double* _Px, long _Lexp); short __cdecl _fdscale( float* _Px, long _Lexp); short __cdecl _dunscale( short* _Pex, double* _Px); short __cdecl _ldunscale( short* _Pex, long double* _Px); short __cdecl _fdunscale( short* _Pex, float* _Px); short __cdecl _dexp( double* _Px, double _Y, long _Eoff); short __cdecl _ldexp( long double* _Px, long double _Y, long _Eoff); short __cdecl _fdexp( float* _Px, float _Y, long _Eoff); short __cdecl _dnorm( unsigned short* _Ps); short __cdecl _fdnorm( unsigned short* _Ps); double __cdecl _dpoly( double _X, double const* _Tab, int _N); long double __cdecl _ldpoly( long double _X, long double const* _Tab, int _N); float __cdecl _fdpoly( float _X, float const* _Tab, int _N); double __cdecl _dlog( double _X, int _Baseflag); long double __cdecl _ldlog( long double _X, int _Baseflag); float __cdecl _fdlog( float _X, int _Baseflag); double __cdecl _dsin( double _X, unsigned int _Qoff); long double __cdecl _ldsin( long double _X, unsigned int _Qoff); float __cdecl _fdsin( float _X, unsigned int _Qoff); typedef union { unsigned short _Sh[4]; double _Val; } _double_val; typedef union { unsigned short _Sh[2]; float _Val; } _float_val; typedef union { unsigned short _Sh[4]; long double _Val; } _ldouble_val; typedef union { unsigned short _Word[4]; float _Float; double _Double; long double _Long_double; } _float_const; extern const _float_const _Denorm_C, _Inf_C, _Nan_C, _Snan_C, _Hugeval_C; extern const _float_const _FDenorm_C, _FInf_C, _FNan_C, _FSnan_C; extern const _float_const _LDenorm_C, _LInf_C, _LNan_C, _LSnan_C; extern const _float_const _Eps_C, _Rteps_C; extern const _float_const _FEps_C, _FRteps_C; extern const _float_const _LEps_C, _LRteps_C; extern const double _Zero_C, _Xbig_C; extern const float _FZero_C, _FXbig_C; extern const long double _LZero_C, _LXbig_C; #line 286 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" int __cdecl abs( int _X); long __cdecl labs( long _X); long long __cdecl llabs( long long _X); double __cdecl acos( double _X); double __cdecl asin( double _X); double __cdecl atan( double _X); double __cdecl atan2( double _Y, double _X); double __cdecl cos( double _X); double __cdecl cosh( double _X); double __cdecl exp( double _X); double __cdecl fabs( double _X); double __cdecl fmod( double _X, double _Y); double __cdecl log( double _X); double __cdecl log10( double _X); double __cdecl pow( double _X, double _Y); double __cdecl sin( double _X); double __cdecl sinh( double _X); double __cdecl sqrt( double _X); double __cdecl tan( double _X); double __cdecl tanh( double _X); double __cdecl acosh( double _X); double __cdecl asinh( double _X); double __cdecl atanh( double _X); double __cdecl atof( char const* _String); double __cdecl _atof_l( char const* _String, _locale_t _Locale); double __cdecl _cabs( struct _complex _Complex_value); double __cdecl cbrt( double _X); double __cdecl ceil( double _X); double __cdecl _chgsign( double _X); double __cdecl copysign( double _Number, double _Sign); double __cdecl _copysign( double _Number, double _Sign); double __cdecl erf( double _X); double __cdecl erfc( double _X); double __cdecl exp2( double _X); double __cdecl expm1( double _X); double __cdecl fdim( double _X, double _Y); double __cdecl floor( double _X); double __cdecl fma( double _X, double _Y, double _Z); double __cdecl fmax( double _X, double _Y); double __cdecl fmin( double _X, double _Y); double __cdecl frexp( double _X, int* _Y); double __cdecl hypot( double _X, double _Y); double __cdecl _hypot( double _X, double _Y); int __cdecl ilogb( double _X); double __cdecl ldexp( double _X, int _Y); double __cdecl lgamma( double _X); long long __cdecl llrint( double _X); long long __cdecl llround( double _X); double __cdecl log1p( double _X); double __cdecl log2( double _X); double __cdecl logb( double _X); long __cdecl lrint( double _X); long __cdecl lround( double _X); int __cdecl _matherr( struct _exception* _Except); double __cdecl modf( double _X, double* _Y); double __cdecl nan( char const* _X); double __cdecl nearbyint( double _X); double __cdecl nextafter( double _X, double _Y); double __cdecl nexttoward( double _X, long double _Y); double __cdecl remainder( double _X, double _Y); double __cdecl remquo( double _X, double _Y, int* _Z); double __cdecl rint( double _X); double __cdecl round( double _X); double __cdecl scalbln( double _X, long _Y); double __cdecl scalbn( double _X, int _Y); double __cdecl tgamma( double _X); double __cdecl trunc( double _X); double __cdecl _j0( double _X ); double __cdecl _j1( double _X ); double __cdecl _jn(int _X, double _Y); double __cdecl _y0( double _X); double __cdecl _y1( double _X); double __cdecl _yn( int _X, double _Y); float __cdecl acoshf( float _X); float __cdecl asinhf( float _X); float __cdecl atanhf( float _X); float __cdecl cbrtf( float _X); float __cdecl _chgsignf( float _X); float __cdecl copysignf( float _Number, float _Sign); float __cdecl _copysignf( float _Number, float _Sign); float __cdecl erff( float _X); float __cdecl erfcf( float _X); float __cdecl expm1f( float _X); float __cdecl exp2f( float _X); float __cdecl fdimf( float _X, float _Y); float __cdecl fmaf( float _X, float _Y, float _Z); float __cdecl fmaxf( float _X, float _Y); float __cdecl fminf( float _X, float _Y); float __cdecl _hypotf( float _X, float _Y); int __cdecl ilogbf( float _X); float __cdecl lgammaf( float _X); long long __cdecl llrintf( float _X); long long __cdecl llroundf( float _X); float __cdecl log1pf( float _X); float __cdecl log2f( float _X); float __cdecl logbf( float _X); long __cdecl lrintf( float _X); long __cdecl lroundf( float _X); float __cdecl nanf( char const* _X); float __cdecl nearbyintf( float _X); float __cdecl nextafterf( float _X, float _Y); float __cdecl nexttowardf( float _X, long double _Y); float __cdecl remainderf( float _X, float _Y); float __cdecl remquof( float _X, float _Y, int* _Z); float __cdecl rintf( float _X); float __cdecl roundf( float _X); float __cdecl scalblnf( float _X, long _Y); float __cdecl scalbnf( float _X, int _Y); float __cdecl tgammaf( float _X); float __cdecl truncf( float _X); float __cdecl _logbf( float _X); float __cdecl _nextafterf( float _X, float _Y); int __cdecl _finitef( float _X); int __cdecl _isnanf( float _X); int __cdecl _fpclassf( float _X); int __cdecl _set_FMA3_enable( int _Flag); int __cdecl _get_FMA3_enable(void); #line 606 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" float __cdecl acosf( float _X); float __cdecl asinf( float _X); float __cdecl atan2f( float _Y, float _X); float __cdecl atanf( float _X); float __cdecl ceilf( float _X); float __cdecl cosf( float _X); float __cdecl coshf( float _X); float __cdecl expf( float _X); #line 663 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" __inline float __cdecl __MS_fabsf( float _X) { return (float)fabs(_X); } float __cdecl floorf( float _X); float __cdecl fmodf( float _X, float _Y); #line 695 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" __inline float __cdecl __MS_frexpf( float _X, int *_Y) { return (float)frexp(_X, _Y); } __inline float __cdecl __MS_hypotf( float _X, float _Y) { return _hypotf(_X, _Y); } __inline float __cdecl __MS_ldexpf( float _X, int _Y) { return (float)ldexp(_X, _Y); } float __cdecl log10f( float _X); float __cdecl logf( float _X); float __cdecl modff( float _X, float *_Y); float __cdecl powf( float _X, float _Y); float __cdecl sinf( float _X); float __cdecl sinhf( float _X); float __cdecl sqrtf( float _X); float __cdecl tanf( float _X); float __cdecl tanhf( float _X); #line 774 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" long double __cdecl acoshl( long double _X); __inline long double __cdecl __MS_acosl( long double _X) { return acos((double)_X); } long double __cdecl asinhl( long double _X); __inline long double __cdecl __MS_asinl( long double _X) { return asin((double)_X); } __inline long double __cdecl __MS_atan2l( long double _Y, long double _X) { return atan2((double)_Y, (double)_X); } long double __cdecl atanhl( long double _X); __inline long double __cdecl __MS_atanl( long double _X) { return atan((double)_X); } long double __cdecl cbrtl( long double _X); __inline long double __cdecl __MS_ceill( long double _X) { return ceil((double)_X); } __inline long double __cdecl _chgsignl( long double _X) { return _chgsign((double)_X); } long double __cdecl copysignl( long double _Number, long double _Sign); __inline long double __cdecl _copysignl( long double _Number, long double _Sign) { return _copysign((double)_Number, (double)_Sign); } __inline long double __cdecl __MS_coshl( long double _X) { return cosh((double)_X); } __inline long double __cdecl __MS_cosl( long double _X) { return cos((double)_X); } long double __cdecl erfl( long double _X); long double __cdecl erfcl( long double _X); __inline long double __cdecl __MS_expl( long double _X) { return exp((double)_X); } long double __cdecl exp2l( long double _X); long double __cdecl expm1l( long double _X); __inline long double __cdecl __MS_fabsl( long double _X) { return fabs((double)_X); } long double __cdecl fdiml( long double _X, long double _Y); __inline long double __cdecl __MS_floorl( long double _X) { return floor((double)_X); } long double __cdecl fmal( long double _X, long double _Y, long double _Z); long double __cdecl fmaxl( long double _X, long double _Y); long double __cdecl fminl( long double _X, long double _Y); __inline long double __cdecl __MS_fmodl( long double _X, long double _Y) { return fmod((double)_X, (double)_Y); } __inline long double __cdecl __MS_frexpl( long double _X, int *_Y) { return frexp((double)_X, _Y); } int __cdecl ilogbl( long double _X); __inline long double __cdecl _hypotl( long double _X, long double _Y) { return _hypot((double)_X, (double)_Y); } __inline long double __cdecl __MS_hypotl( long double _X, long double _Y) { return _hypot((double)_X, (double)_Y); } __inline long double __cdecl __MS_ldexpl( long double _X, int _Y) { return ldexp((double)_X, _Y); } long double __cdecl lgammal( long double _X); long long __cdecl llrintl( long double _X); long long __cdecl llroundl( long double _X); __inline long double __cdecl __MS_logl( long double _X) { return log((double)_X); } __inline long double __cdecl __MS_log10l( long double _X) { return log10((double)_X); } long double __cdecl log1pl( long double _X); long double __cdecl log2l( long double _X); long double __cdecl logbl( long double _X); long __cdecl lrintl( long double _X); long __cdecl lroundl( long double _X); __inline long double __cdecl __MS_modfl( long double _X, long double* _Y) { double _F, _I; _F = modf((double)_X, &_I); *_Y = _I; return _F; } long double __cdecl nanl( char const* _X); long double __cdecl nearbyintl( long double _X); long double __cdecl nextafterl( long double _X, long double _Y); long double __cdecl nexttowardl( long double _X, long double _Y); __inline long double __cdecl __MS_powl( long double _X, long double _Y) { return pow((double)_X, (double)_Y); } long double __cdecl remainderl( long double _X, long double _Y); long double __cdecl remquol( long double _X, long double _Y, int* _Z); long double __cdecl rintl( long double _X); long double __cdecl roundl( long double _X); long double __cdecl scalblnl( long double _X, long _Y); long double __cdecl scalbnl( long double _X, int _Y); __inline long double __cdecl __MS_sinhl( long double _X) { return sinh((double)_X); } __inline long double __cdecl __MS_sinl( long double _X) { return sin((double)_X); } __inline long double __cdecl __MS_sqrtl( long double _X) { return sqrt((double)_X); } __inline long double __cdecl __MS_tanhl( long double _X) { return tanh((double)_X); } __inline long double __cdecl __MS_tanl( long double _X) { return tan((double)_X); } long double __cdecl tgammal( long double _X); long double __cdecl truncl( long double _X); #line 971 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_math.h" extern double HUGE; __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_j0" ". See online help for details.")) double __cdecl j0( double _X); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_j1" ". See online help for details.")) double __cdecl j1( double _X); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_jn" ". See online help for details.")) double __cdecl jn( int _X, double _Y); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_y0" ". See online help for details.")) double __cdecl y0( double _X); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_y1" ". See online help for details.")) double __cdecl y1( double _X); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_yn" ". See online help for details.")) double __cdecl yn( int _X, double _Y); #pragma warning(pop) __pragma(pack(pop)) #line 12 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\math.h" #line 142 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 176 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 226 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math_common_define.h" #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math_common_define.h" #line 39 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math_common_define.h" #line 59 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math_common_define.h" #line 231 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 245 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 271 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 285 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 307 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 354 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 370 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern int fpclassifyf ( float __x ) ; extern int fpclassify ( double __x ) ; extern int fpclassifyd ( double __x ) ; extern int fpclassifyl ( long double __x ) ; extern int isinff ( float __x ) ; extern int isinf ( double __x ) ; extern int isinfd ( double __x ) ; extern int isinfl ( long double __x ) ; extern int isnanf ( float __x ) ; extern int isnan ( double __x ) ; extern int isnand ( double __x ) ; extern int isnanl ( long double __x ) ; extern int isnormalf ( float __x ) ; extern int isnormal ( double __x ) ; extern int isnormald ( double __x ) ; extern int isnormall ( long double __x ) ; extern int isfinitef ( float __x ) ; extern int isfinite ( double __x ) ; extern int isfinited ( double __x ) ; extern int isfinitel ( long double __x ) ; extern int finitef ( float __x ) ; extern int finite ( double __x ) ; extern int finited ( double __x ) ; extern int finitel ( long double __x ) ; extern int signbitf ( float __x ) ; extern int signbit ( double __x ) ; extern int signbitd ( double __x ) ; extern int signbitl ( long double __x ) ; extern int __fpclassifyf ( float __x ) ; extern int __fpclassify ( double __x ) ; extern int __fpclassifyd ( double __x ) ; extern int __fpclassifyl ( long double __x ) ; extern int __isinff ( float __x ) ; extern int __isinf ( double __x ) ; extern int __isinfd ( double __x ) ; extern int __isinfl ( long double __x ) ; extern int __isnanf ( float __x ) ; extern int __isnan ( double __x ) ; extern int __isnand ( double __x ) ; extern int __isnanl ( long double __x ) ; extern int __isnormalf ( float __x ) ; extern int __isnormal ( double __x ) ; extern int __isnormald ( double __x ) ; extern int __isnormall ( long double __x ) ; extern int __isfinitef ( float __x ) ; extern int __isfinite ( double __x ) ; extern int __isfinited ( double __x ) ; extern int __isfinitel ( long double __x ) ; extern int __finitef ( float __x ) ; extern int __finite ( double __x ) ; extern int __finited ( double __x ) ; extern int __finitel ( long double __x ) ; extern int __signbitf ( float __x ) ; extern int __signbit ( double __x ) ; extern int __signbitd ( double __x ) ; extern int __signbitl ( long double __x ) ; #line 470 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 487 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 509 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 516 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern int isgreaterf( float __xf, float __yf ); extern int isgreater( double __xd, double __yd ); extern int isgreaterl( long double __xl, long double __yl ); extern int __isgreaterf( float __xf, float __yf ); extern int __isgreater( double __xd, double __yd ); extern int __isgreaterl( long double __xl, long double __yl ); extern int isgreaterequalf( float __xf, float __yf ); extern int isgreaterequal( double __xd, double __yd ); extern int isgreaterequall( long double __xl, long double __yl ); extern int __isgreaterequalf( float __xf, float __yf ); extern int __isgreaterequal( double __xd, double __yd ); extern int __isgreaterequall( long double __xl, long double __yl ); extern int islessf( float __xf, float __yf ); extern int isless( double __xd, double __yd ); extern int islessl( long double __xl, long double __yl ); extern int __islessf( float __xf, float __yf ); extern int __isless( double __xd, double __yd ); extern int __islessl( long double __xl, long double __yl ); int islessequalf( float __xf, float __yf ); extern int islessequal( double __xd, double __yd ); extern int islessequall( long double __xl, long double __yl ); extern int __islessequalf( float __xf, float __yf ); extern int __islessequal( double __xd, double __yd ); extern int __islessequall( long double __xl, long double __yl ); extern int islessgreaterf( float __xf, float __yf ); extern int islessgreater( double __xd, double __yd ); extern int islessgreaterl( long double __xl, long double __yl ); extern int __islessgreaterf( float __xf, float __yf ); extern int __islessgreater( double __xd, double __yd ); extern int __islessgreaterl( long double __xl, long double __yl ); extern int isunorderedf( float __xf, float __yf ); extern int isunordered( double __xd, double __yd ); extern int isunorderedl( long double __xl, long double __yl ); extern int __isunorderedf( float __xf, float __yf ); extern int __isunordered( double __xd, double __yd ); extern int __isunorderedl( long double __xl, long double __yl ); #line 584 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 594 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 612 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern float __cdecl acosf( float __x ); extern float __cdecl asinf( float __x ); extern float __cdecl atanf( float __x ); extern float __cdecl atan2f( float __y, float __x ); extern float __cdecl cosf( float __x ); extern float __cdecl sinf( float __x ); extern float __cdecl tanf( float __x ); extern double __cdecl acosh( double __x ); extern float __cdecl acoshf( float __x ); extern double __cdecl asinh( double __x ); extern float __cdecl asinhf( float __x ); extern double __cdecl atanh( double __x ); extern float __cdecl atanhf( float __x ); #line 647 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern float __cdecl coshf( float __x ); extern float __cdecl sinhf( float __x ); extern float __cdecl tanhf( float __x ); extern float __cdecl expf( float __x ); extern double __cdecl expm1( double __x ); extern float __cdecl expm1f( float __x ); extern double __cdecl exp2( double __x ); extern float __cdecl exp2f( float __x ); #line 688 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern float __cdecl frexpf( float __x, int *__exp ); extern float __cdecl ldexpf( float __x, int __exp ); extern float __cdecl nanf( const char* __tagp ); extern double __cdecl nan ( const char* __tagp ); extern long double __cdecl nanl( const char* __tagp ); extern double __cdecl scalb( double __x, double __y ); extern float __cdecl scalbf( float __x, float __y ); extern double __cdecl scalbn( double __x, int __n ); extern float __cdecl scalbnf( float __x, int __n ); extern double __cdecl scalbln( double __x, long int __n ); extern float __cdecl scalblnf( float __x, long int __n ); #line 728 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern float __cdecl logf( float __x ); extern float __cdecl log10f( float __x ); extern double __cdecl log2( double __x ); extern float __cdecl log2f( float __x ); extern double __cdecl log1p( double __x ); extern float __cdecl log1pf( float __x ); extern double __cdecl logb( double __x ); extern float __cdecl logbf( float __x ); extern int __cdecl ilogb( double __x ); extern int __cdecl ilogbf( float __x ); extern float __cdecl modff( float __x, float *__iptr ); extern double __cdecl cbrt( double __x ); extern float __cdecl cbrtf( float __x ); #line 780 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern float __cdecl fabsf( float __x ); extern double __cdecl hypot( double __x, double __y ); extern float __cdecl hypotf( float __x, float __y ); extern float __cdecl powf( float __x, float __y ); extern float __cdecl sqrtf( float __x ); extern double __cdecl erf( double __x ); extern float __cdecl erff( float __x ); extern double __cdecl erfc( double __x ); extern float __cdecl erfcf( float __x ); extern double __cdecl lgamma( double __x ); extern float __cdecl lgammaf( float __x ); extern double __cdecl gamma( double __x ); extern float __cdecl gammaf( float __x ); extern double __cdecl lgamma_r(double __x, int *__signgam); extern float __cdecl lgammaf_r( float __x, int *__signgam ); extern double __cdecl gamma_r( double __x, int *__signgam ); extern float __cdecl gammaf_r( float __x, int *__signgam ); extern double __cdecl tgamma( double __x ); extern float __cdecl tgammaf( float __x ); #line 829 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" extern float __cdecl ceilf( float __x ); extern float __cdecl floorf( float __x ); extern double __cdecl nearbyint( double __x ); extern float __cdecl nearbyintf( float __x ); extern double __cdecl rint( double __x ); extern float __cdecl rintf( float __x ); extern long int __cdecl lrint( double __x ); extern long int __cdecl lrintf( float __x ); extern long long int __cdecl llrint( double __x ); extern long long int __cdecl llrintf( float __x ); extern double __cdecl round( double __x ); extern float __cdecl roundf( float __x ); extern long int __cdecl lround( double __x ); extern long int __cdecl lroundf( float __x ); extern long long int __cdecl llround( double __x ); extern long long int __cdecl llroundf( float __x ); extern double __cdecl trunc( double __x ); extern float __cdecl truncf( float __x ); extern float __cdecl fmodf( float __x, float __y ); extern double __cdecl remainder( double __x, double __y ); extern float __cdecl remainderf( float __x, float __y ); extern double __cdecl remquo( double __x, double __y, int *__quo ); extern float __cdecl remquof( float __x, float __y, int *__quo ); extern double __cdecl copysign( double __x, double __y ); extern float __cdecl copysignf( float __x, float __y ); extern double __cdecl nextafter( double __x, double __y ); extern float __cdecl nextafterf( float __x, float __y ); extern double __cdecl __libm_nexttoward64 ( double __x, long double __y ); extern float __cdecl __libm_nexttoward64f( float __x, double __y ); extern double __cdecl __libm_nexttoward64l( double __x, double __y ); extern double __cdecl fdim( double __x, double __y ); extern float __cdecl fdimf( float __x, float __y ); extern double __cdecl fmax( double __x, double __y ); extern float __cdecl fmaxf( float __x, float __y ); extern double __cdecl fmin( double __x, double __y ); extern float __cdecl fminf( float __x, float __y ); extern double __cdecl fma( double __x, double __y, double __z ); extern float __cdecl fmaf( float __x, float __y, float __z ); __forceinline long double __cdecl acosl( long double __x ) {return (long double) acos((double) __x);} __forceinline long double __cdecl asinl( long double __x ) {return (long double) asin((double) __x);} __forceinline long double __cdecl atan2l( long double __y, long double __x ) {return (long double) atan2((double)__y, (double) __x );} __forceinline long double __cdecl atanl( long double __x ) {return (long double) atan((double) __x);} __forceinline long double __cdecl ceill( long double __x ) {return (long double) ceil((double) __x);} __forceinline long double __cdecl cosl( long double __x ) {return (long double) cos((double) __x);} __forceinline long double __cdecl coshl( long double __x ) {return (long double) cosh((double) __x);} __forceinline long double __cdecl expl( long double __x ) {return (long double) exp((double) __x);} __forceinline long double __cdecl fabsl( long double __x ) {return (long double) fabs((double) __x);} __forceinline long double __cdecl floorl( long double __x ) {return (long double) floor((double) __x);} __forceinline long double __cdecl fmodl( long double __x, long double __y ) {return (long double) fmod((double)__x, (double) __y );} __forceinline long double __cdecl frexpl( long double __x, int *__exp ) {return (long double) frexp((double)__x, __exp );} __forceinline long double __cdecl hypotl( long double __x, long double __y ) {return (long double) hypot((double)__x, (double) __y );} __forceinline long double __cdecl ldexpl( long double __x, int __exp ) {return (long double) ldexp((double)__x, __exp );} __forceinline long double __cdecl logl( long double __x ) {return (long double) log((double) __x);} __forceinline long double __cdecl log10l( long double __x ) {return (long double) log10((double) __x);} __forceinline long double __cdecl modfl( long double __x, long double *__iptr ) {return (long double) modf((double)__x, (double *) __iptr );} __forceinline long double __cdecl powl( long double __x, long double __y ) {return (long double) pow((double)__x, (double) __y );} __forceinline long double __cdecl sinhl( long double __x ) {return (long double) sinh((double) __x);} __forceinline long double __cdecl sinl( long double __x ) {return (long double) sin((double) __x);} __forceinline long double __cdecl sqrtl( long double __x ) {return (long double) sqrt((double) __x);} __forceinline long double __cdecl tanl( long double __x ) {return (long double) tan((double) __x);} __forceinline long double __cdecl tanhl( long double __x ) {return (long double) tanh((double) __x);} __forceinline long double __cdecl acoshl( long double __x ) {return (long double) acosh((double) __x);} __forceinline long double __cdecl asinhl( long double __x ) {return (long double) asinh((double) __x);} __forceinline long double __cdecl atanhl( long double __x ) {return (long double) atanh((double) __x);} __forceinline long double __cdecl cbrtl( long double __x ) {return (long double) cbrt((double) __x);} __forceinline long double __cdecl copysignl( long double __x, long double __y ) {return (long double) copysign((double)__x, (double) __y );} __forceinline long double __cdecl erfcl( long double __x ) {return (long double) erfc((double) __x);} __forceinline long double __cdecl erfl( long double __x ) {return (long double) erf((double) __x);} __forceinline int __cdecl ilogbl( long double __x ) {return (long double) ilogb((double) __x);} __forceinline long double __cdecl gammal( long double __x ) {return (long double) gamma((double) __x);} __forceinline long double __cdecl gammal_r( long double __x, int *__signgam ) {return (long double) gamma_r((double) __x, __signgam);} __forceinline long double __cdecl lgammal( long double __x ) {return (long double) lgamma((double) __x);} __forceinline long double __cdecl lgammal_r( long double __x, int *__signgam ) {return (long double) lgamma_r((double) __x, __signgam);} __forceinline long double __cdecl log1pl( long double __x ) {return (long double) log1p((double) __x);} __forceinline long double __cdecl logbl( long double __x ) {return (long double) logb((double) __x);} __forceinline long double __cdecl nextafterl( long double __x, long double __y ) {return (long double) nextafter((double)__x, (double) __y );} __forceinline long double __cdecl remainderl( long double __x, long double __y ) {return (long double) remainder((double)__x, (double) __y );} __forceinline long double __cdecl rintl( long double __x ) {return (long double) rint((double) __x);} __forceinline long double __cdecl scalbnl( long double __x, int __n ) {return (long double) scalbn((double)__x, __n );} __forceinline long double __cdecl exp2l( long double __x ) {return (long double) exp2((double) __x);} __forceinline long double __cdecl expm1l( long double __x ) {return (long double) expm1((double) __x);} __forceinline long double __cdecl fdiml( long double __x, long double __y ) {return (long double) fdim((double)__x, (double) __y );} __forceinline long double __cdecl fmal( long double __x, long double __y, long double __z ) {return (long double) fma((double) __x, (double) __y, (double) __z);} __forceinline long double __cdecl fmaxl( long double __x, long double __y ) {return (long double) fmax((double)__x, (double) __y );} __forceinline long double __cdecl fminl( long double __x, long double __y ) {return (long double) fmin((double)__x, (double) __y );} __forceinline long long int __cdecl llrintl( long double __x ) {return (long double) llrint((double) __x);} __forceinline long long int __cdecl llroundl( long double __x ) {return (long double) llround((double) __x);} __forceinline long double __cdecl log2l( long double __x ) {return (long double) log2((double) __x);} __forceinline long int __cdecl lrintl( long double __x ) {return (long double) lrint((double) __x);} __forceinline long int __cdecl lroundl( long double __x ) {return (long double) lround((double) __x);} __forceinline long double __cdecl nearbyintl( long double __x ) {return (long double) nearbyint((double) __x);} __forceinline long double __cdecl nexttowardl( long double __x, long double __y ) {return (long double) __libm_nexttoward64l((double)__x, (double) __y );} __forceinline double __cdecl nexttoward( double __x, long double __y ) {return __libm_nexttoward64l(__x, (double) __y );} __forceinline float __cdecl nexttowardf( float __x, long double __y ) {return __libm_nexttoward64f(__x, (double) __y );} __forceinline long double __cdecl remquol( long double __x, long double __y, int *__quo ) {return (long double) remquo((double) __x, (double) __y, __quo);} __forceinline long double __cdecl roundl( long double __x ) {return (long double) round((double) __x);} __forceinline long double __cdecl scalbl( long double __x, long double __y ) {return (long double) scalb((double)__x, (double) __y );} __forceinline long double __cdecl scalblnl( long double __x, long int __n ) {return (long double) scalbln((double)__x, __n );} __forceinline long double __cdecl tgammal( long double __x ) {return (long double) tgamma((double) __x);} __forceinline long double __cdecl truncl( long double __x ) {return (long double) trunc((double) __x);} #line 1133 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 1147 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" typedef struct ____exception { int type; const char *name; double arg1; double arg2; double retval; } ___exception; #line 1168 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" typedef struct ____exceptionf { int type; const char *name; float arg1; float arg2; float retval; } ___exceptionf; typedef struct ____exceptionl { int type; const char *name; long double arg1; long double arg2; long double retval; } ___exceptionl; extern int __cdecl matherrf( struct ____exceptionf *__e ); extern int __cdecl matherrl( struct ____exceptionl *__e ); typedef int ( __cdecl *___pmatherr )( struct ____exception *__e ); typedef int ( __cdecl *___pmatherrf )( struct ____exceptionf *__e ); typedef int ( __cdecl *___pmatherrl )( struct ____exceptionl *__e ); extern ___pmatherr __cdecl __libm_setusermatherr( ___pmatherr __user_matherr ); extern ___pmatherrf __cdecl __libm_setusermatherrf( ___pmatherrf __user_matherrf ); extern ___pmatherrl __cdecl __libm_setusermatherrl( ___pmatherrl __user_matherrl ); typedef enum ___LIB_VERSIONIMF_TYPE { _IEEE_ = -1 ,_SVID_ ,_XOPEN_ ,_POSIX_ ,_ISOC_ } _LIB_VERSIONIMF_TYPE; extern _LIB_VERSIONIMF_TYPE _LIB_VERSIONIMF; #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math_common_undefine.h" #line 1234 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\math.h" #line 142 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 176 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 226 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\math.h" #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_MATH_H" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(6): error: identifier "M_PI" is undefined double pi = M_PI; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(6): error: identifier "M_PI" is undefined double pi = M_PI; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { double pi = M_PI; if (pi); ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #define _USE_MATH_DEFINES 1 #include int main() { double pi = M_PI; if (pi); ; return 0; } Defined "_USE_MATH_DEFINES" to "1" Activated Windows math #defines, like M_PI Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { double f = INFINITY; if (f); ; return 0; } Defined "HAVE_MATH_INFINITY" to "1" Found math INFINITY ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sys/socket.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/socket.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/socket.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sys/types.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\sys/types.h" #pragma once typedef unsigned short _ino_t; typedef _ino_t ino_t; typedef unsigned int _dev_t; typedef _dev_t dev_t; typedef long _off_t; typedef _off_t off_t; #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_SYS_TYPES_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: malloc.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" #pragma once __pragma(pack(push, 8)) #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __declspec(allocator) __declspec(restrict) void* __cdecl _calloc_base( size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl calloc( size_t _Count, size_t _Size ); int __cdecl _callnewh( size_t _Size ); __declspec(allocator) void* __cdecl _expand( void* _Block, size_t _Size ); void __cdecl _free_base( void* _Block ); void __cdecl free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _malloc_base( size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl malloc( size_t _Size ); size_t __cdecl _msize_base( void* _Block ); size_t __cdecl _msize( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _realloc_base( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl realloc( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc_base( void* _Block, size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc( void* _Block, size_t _Count, size_t _Size ); void __cdecl _aligned_free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_malloc( size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_malloc( size_t _Size, size_t _Alignment, size_t _Offset ); size_t __cdecl _aligned_msize( void* _Block, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_realloc( void* _Block, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_realloc( void* _Block, size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment ); #line 225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" __pragma(pack(push, 8)) #line 37 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" typedef struct _heapinfo { int* _pentry; size_t _size; int _useflag; } _HEAPINFO; void* __cdecl _alloca( size_t _Size); intptr_t __cdecl _get_heap_handle(void); int __cdecl _heapmin(void); int __cdecl _heapwalk( _HEAPINFO* _EntryInfo); int __cdecl _heapchk(void); int __cdecl _resetstkoflw(void); typedef char __static_assert_t[(sizeof(unsigned int) <= 16) != 0]; #pragma warning(push) #pragma warning(disable:6540) __inline void* _MarkAllocaS( void* _Ptr, unsigned int _Marker) { if (_Ptr) { *((unsigned int*)_Ptr) = _Marker; _Ptr = (char*)_Ptr + 16; } return _Ptr; } __inline size_t _MallocaComputeSize(size_t _Size) { size_t _MarkedSize = _Size + 16; return _MarkedSize > _Size ? _MarkedSize : 0; } #pragma warning(pop) #line 126 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" #line 135 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" #pragma warning(push) #pragma warning(disable: 6014) __inline void __cdecl _freea( void* _Memory) { unsigned int _Marker; if (_Memory) { _Memory = (char*)_Memory - 16; _Marker = *(unsigned int*)_Memory; if (_Marker == 0xDDDD) { free(_Memory); } #line 165 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" } } #pragma warning(pop) __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_MALLOC_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: time.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\time.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\time.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wtime.h" #pragma once __pragma(pack(push, 8)) struct tm { int tm_sec; int tm_min; int tm_hour; int tm_mday; int tm_mon; int tm_year; int tm_wday; int tm_yday; int tm_isdst; }; __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wasctime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wasctime( struct tm const* _Tm ); errno_t __cdecl _wasctime_s( wchar_t* _Buffer, size_t _SizeInWords, struct tm const* _Tm ); size_t __cdecl wcsftime( wchar_t* _Buffer, size_t _SizeInWords, wchar_t const* _Format, struct tm const* _Tm ); size_t __cdecl _wcsftime_l( wchar_t* _Buffer, size_t _SizeInWords, wchar_t const* _Format, struct tm const* _Tm, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctime32_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wctime32( __time32_t const* _Time ); errno_t __cdecl _wctime32_s( wchar_t* _Buffer, size_t _SizeInWords, __time32_t const* _Time ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctime64_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wctime64( __time64_t const* _Time ); errno_t __cdecl _wctime64_s( wchar_t* _Buffer, size_t _SizeInWords, __time64_t const* _Time); errno_t __cdecl _wstrdate_s( wchar_t* _Buffer, size_t _SizeInWords ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wstrdate_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wstrdate( wchar_t *_Buffer); errno_t __cdecl _wstrtime_s( wchar_t* _Buffer, size_t _SizeInWords ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wstrtime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wstrtime( wchar_t *_Buffer); #pragma warning(push) #pragma warning(disable: 4996) #line 183 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wtime.h" static __inline wchar_t * __cdecl _wctime( time_t const* const _Time) { return _wctime64(_Time); } static __inline errno_t __cdecl _wctime_s( wchar_t* const _Buffer, size_t const _SizeInWords, time_t const* const _Time ) { return _wctime64_s(_Buffer, _SizeInWords, _Time); } #pragma warning(pop) __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\time.h" __pragma(pack(push, 8)) typedef long clock_t; struct _timespec32 { __time32_t tv_sec; long tv_nsec; }; struct _timespec64 { __time64_t tv_sec; long tv_nsec; }; struct timespec { time_t tv_sec; long tv_nsec; }; __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_daylight" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int* __cdecl __daylight(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_dstbias" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) long* __cdecl __dstbias(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_timezone" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) long* __cdecl __timezone(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_tzname" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __tzname(void); errno_t __cdecl _get_daylight( int* _Daylight ); errno_t __cdecl _get_dstbias( long* _DaylightSavingsBias ); errno_t __cdecl _get_timezone( long* _TimeZone ); errno_t __cdecl _get_tzname( size_t* _ReturnValue, char* _Buffer, size_t _SizeInBytes, int _Index ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "asctime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl asctime( struct tm const* _Tm ); errno_t __cdecl asctime_s( char* _Buffer, size_t _SizeInBytes, struct tm const* _Tm ); clock_t __cdecl clock(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ctime32_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ctime32( __time32_t const* _Time ); errno_t __cdecl _ctime32_s( char* _Buffer, size_t _SizeInBytes, __time32_t const* _Time ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ctime64_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ctime64( __time64_t const* _Time ); errno_t __cdecl _ctime64_s( char* _Buffer, size_t _SizeInBytes, __time64_t const* _Time ); double __cdecl _difftime32( __time32_t _Time1, __time32_t _Time2 ); double __cdecl _difftime64( __time64_t _Time1, __time64_t _Time2 ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gmtime32_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) struct tm* __cdecl _gmtime32( __time32_t const* _Time ); errno_t __cdecl _gmtime32_s( struct tm* _Tm, __time32_t const* _Time ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gmtime64_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) struct tm* __cdecl _gmtime64( __time64_t const* _Time ); errno_t __cdecl _gmtime64_s( struct tm* _Tm, __time64_t const* _Time ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_localtime32_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) struct tm* __cdecl _localtime32( __time32_t const* _Time ); errno_t __cdecl _localtime32_s( struct tm* _Tm, __time32_t const* _Time ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_localtime64_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) struct tm* __cdecl _localtime64( __time64_t const* _Time ); errno_t __cdecl _localtime64_s( struct tm* _Tm, __time64_t const* _Time ); __time32_t __cdecl _mkgmtime32( struct tm* _Tm ); __time64_t __cdecl _mkgmtime64( struct tm* _Tm ); __time32_t __cdecl _mktime32( struct tm* _Tm ); __time64_t __cdecl _mktime64( struct tm* _Tm ); size_t __cdecl strftime( char* _Buffer, size_t _SizeInBytes, char const* _Format, struct tm const* _Tm ); size_t __cdecl _strftime_l( char* _Buffer, size_t _MaxSize, char const* _Format, struct tm const* _Tm, _locale_t _Locale ); errno_t __cdecl _strdate_s( char* _Buffer, size_t _SizeInBytes ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strdate_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strdate( char *_Buffer); errno_t __cdecl _strtime_s( char* _Buffer, size_t _SizeInBytes ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strtime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strtime( char *_Buffer); __time32_t __cdecl _time32( __time32_t* _Time ); __time64_t __cdecl _time64( __time64_t* _Time ); int __cdecl _timespec32_get( struct _timespec32* _Ts, int _Base ); int __cdecl _timespec64_get( struct _timespec64* _Ts, int _Base ); void __cdecl _tzset(void); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "GetLocalTime" " " "instead. See online help for details.")) unsigned __cdecl _getsystime( struct tm* _Tm ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "SetLocalTime" " " "instead. See online help for details.")) unsigned __cdecl _setsystime( struct tm* _Tm, unsigned _Milliseconds ); #line 474 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\time.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "ctime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) static __inline char* __cdecl ctime( time_t const* const _Time ) { #pragma warning(push) #pragma warning(disable: 4996) return _ctime64(_Time); #pragma warning(pop) } static __inline double __cdecl difftime( time_t const _Time1, time_t const _Time2 ) { return _difftime64(_Time1, _Time2); } __declspec(deprecated("This function or variable may be unsafe. Consider using " "gmtime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) static __inline struct tm* __cdecl gmtime( time_t const* const _Time) { #pragma warning(push) #pragma warning(disable: 4996) return _gmtime64(_Time); #pragma warning(pop) } __declspec(deprecated("This function or variable may be unsafe. Consider using " "localtime_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) static __inline struct tm* __cdecl localtime( time_t const* const _Time ) { #pragma warning(push) #pragma warning(disable: 4996) return _localtime64(_Time); #pragma warning(pop) } static __inline time_t __cdecl _mkgmtime( struct tm* const _Tm ) { return _mkgmtime64(_Tm); } static __inline time_t __cdecl mktime( struct tm* const _Tm ) { return _mktime64(_Tm); } static __inline time_t __cdecl time( time_t* const _Time ) { return _time64(_Time); } static __inline int __cdecl timespec_get( struct timespec* const _Ts, int const _Base ) { return _timespec64_get((struct _timespec64*)_Ts, _Base); } static __inline errno_t __cdecl ctime_s( char* const _Buffer, size_t const _SizeInBytes, time_t const* const _Time ) { return _ctime64_s(_Buffer, _SizeInBytes, _Time); } static __inline errno_t __cdecl gmtime_s( struct tm* const _Tm, time_t const* const _Time ) { return _gmtime64_s(_Tm, _Time); } static __inline errno_t __cdecl localtime_s( struct tm* const _Tm, time_t const* const _Time ) { return _localtime64_s(_Tm, _Time); } __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_tzset" ". See online help for details.")) void __cdecl tzset(void); __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_TIME_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: Direct.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\Direct.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\Direct.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wdirect.h" #pragma once __pragma(pack(push, 8)) __declspec(allocator) wchar_t* __cdecl _wgetcwd( wchar_t* _DstBuf, int _SizeInWords ); __declspec(allocator) wchar_t* __cdecl _wgetdcwd( int _Drive, wchar_t* _DstBuf, int _SizeInWords ); int __cdecl _wchdir( wchar_t const* _Path ); int __cdecl _wmkdir( wchar_t const* _Path ); int __cdecl _wrmdir( wchar_t const* _Path ); __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\Direct.h" __pragma(pack(push, 8)) struct _diskfree_t { unsigned total_clusters; unsigned avail_clusters; unsigned sectors_per_cluster; unsigned bytes_per_sector; }; unsigned __cdecl _getdiskfree( unsigned _Drive, struct _diskfree_t* _DiskFree ); int __cdecl _chdrive( int _Drive); int __cdecl _getdrive(void); unsigned long __cdecl _getdrives(void); __declspec(allocator) char* __cdecl _getcwd( char* _DstBuf, int _SizeInBytes ); __declspec(allocator) char* __cdecl _getdcwd( int _Drive, char* _DstBuf, int _SizeInBytes ); int __cdecl _chdir( char const* _Path); int __cdecl _mkdir( char const* _Path); int __cdecl _rmdir( char const* _Path); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_getcwd" ". See online help for details.")) char* __cdecl getcwd( char* _DstBuf, int _SizeInBytes ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_chdir" ". See online help for details.")) int __cdecl chdir( char const* _Path ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_mkdir" ". See online help for details.")) int __cdecl mkdir( char const* _Path ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_rmdir" ". See online help for details.")) int __cdecl rmdir( char const* _Path ); __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_DIRECT_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: Ws2tcpip.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\Ws2tcpip.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winapifamily.h" #pragma warning(push) #pragma warning(disable:4001) #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winpackagefamily.h" #pragma warning(push) #pragma warning(disable:4001) #pragma once #line 57 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winpackagefamily.h" #line 84 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winpackagefamily.h" #pragma warning(pop) #line 27 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winapifamily.h" #line 143 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winapifamily.h" #line 154 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winapifamily.h" #pragma warning(pop) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\Ws2tcpip.h" #pragma warning(push) #pragma warning(disable:4365) #pragma warning(disable:4574) #pragma warning(disable:4668) #pragma warning(disable:4820) #line 42 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\Ws2tcpip.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winsock2.h" #pragma once #line 36 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winsock2.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\windows.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdkddkver.h" #pragma warning(push) #pragma warning(disable:4668) #pragma warning(disable:4001) #pragma once #line 44 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdkddkver.h" #line 64 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdkddkver.h" #line 76 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdkddkver.h" #line 100 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdkddkver.h" #line 152 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdkddkver.h" #line 205 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdkddkver.h" #line 224 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdkddkver.h" #line 232 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdkddkver.h" #line 266 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdkddkver.h" #pragma warning(pop) #line 23 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\windows.h" #pragma once #pragma region Application Family or OneCore Family #line 105 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\windows.h" #line 112 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\windows.h" #pragma warning(disable:4116) #pragma warning(disable:4514) #pragma warning(disable:4103) #pragma warning(push) #pragma warning(disable:4001) #pragma warning(disable:4201) #pragma warning(disable:4214) #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\excpt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 13 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\excpt.h" __pragma(pack(push, 8)) typedef enum _EXCEPTION_DISPOSITION { ExceptionContinueExecution, ExceptionContinueSearch, ExceptionNestedException, ExceptionCollidedUnwind } EXCEPTION_DISPOSITION; #line 44 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\excpt.h" struct _EXCEPTION_RECORD; struct _CONTEXT; struct _DISPATCHER_CONTEXT; EXCEPTION_DISPOSITION __cdecl __C_specific_handler( struct _EXCEPTION_RECORD* ExceptionRecord, void* EstablisherFrame, struct _CONTEXT* ContextRecord, struct _DISPATCHER_CONTEXT* DispatcherContext ); #line 68 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\excpt.h" unsigned long __cdecl _exception_code(void); void * __cdecl _exception_info(void); int __cdecl _abnormal_termination(void); __pragma(pack(pop)) #line 168 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\windows.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdarg.h" #pragma once __pragma(pack(push, 8)) __pragma(pack(pop)) #line 169 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\windows.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\windef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\minwindef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #pragma once #pragma warning(push) #pragma warning(disable:4668) #line 39 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 58 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 100 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 186 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 320 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 329 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 346 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 361 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 378 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 417 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 433 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 458 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 497 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 566 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 577 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 606 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 668 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_strict.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_undef.h" #line 456 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_undef.h" #line 189 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_strict.h" #line 395 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_strict.h" #line 438 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_strict.h" #line 462 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_strict.h" #line 655 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_strict.h" #line 835 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_strict.h" #line 1065 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_strict.h" #line 1122 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_strict.h" #line 1136 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings_strict.h" #line 675 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 694 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\driverspecs.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\sdv_driverspecs.h" #line 126 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\driverspecs.h" #pragma once #line 255 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\driverspecs.h" #line 267 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\driverspecs.h" #line 292 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\driverspecs.h" #line 299 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\driverspecs.h" #line 341 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\driverspecs.h" #line 865 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\driverspecs.h" #line 885 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\driverspecs.h" #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\specstrings.h" #pragma warning(pop) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\minwindef.h" #pragma region Application Family or OneCore Family typedef unsigned long ULONG; typedef ULONG *PULONG; typedef unsigned short USHORT; typedef USHORT *PUSHORT; typedef unsigned char UCHAR; typedef UCHAR *PUCHAR; typedef char *PSZ; #line 69 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\minwindef.h" #line 114 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\minwindef.h" #line 141 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\minwindef.h" #line 155 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\minwindef.h" typedef unsigned long DWORD; typedef int BOOL; typedef unsigned char BYTE; typedef unsigned short WORD; typedef float FLOAT; typedef FLOAT *PFLOAT; typedef BOOL *PBOOL; typedef BOOL *LPBOOL; typedef BYTE *PBYTE; typedef BYTE *LPBYTE; typedef int *PINT; typedef int *LPINT; typedef WORD *PWORD; typedef WORD *LPWORD; typedef long *LPLONG; typedef DWORD *PDWORD; typedef DWORD *LPDWORD; typedef void *LPVOID; typedef const void *LPCVOID; typedef int INT; typedef unsigned int UINT; typedef unsigned int *PUINT; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #pragma warning(push) #pragma warning(disable:4668) #pragma warning(disable:4820) #pragma warning(disable:4200) #pragma warning(disable:4201) #pragma warning(disable:4214) #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\ctype.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\ctype.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wctype.h" #pragma once __pragma(pack(push, 8)) const unsigned short* __cdecl __pctype_func(void); const wctype_t* __cdecl __pwctype_func(void); #line 42 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wctype.h" #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wctype.h" int __cdecl iswalnum ( wint_t _C); int __cdecl iswalpha ( wint_t _C); int __cdecl iswascii ( wint_t _C); int __cdecl iswblank ( wint_t _C); int __cdecl iswcntrl ( wint_t _C); int __cdecl iswdigit ( wint_t _C); int __cdecl iswgraph ( wint_t _C); int __cdecl iswlower ( wint_t _C); int __cdecl iswprint ( wint_t _C); int __cdecl iswpunct ( wint_t _C); int __cdecl iswspace ( wint_t _C); int __cdecl iswupper ( wint_t _C); int __cdecl iswxdigit ( wint_t _C); int __cdecl __iswcsymf( wint_t _C); int __cdecl __iswcsym ( wint_t _C); int __cdecl _iswalnum_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswalpha_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswblank_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswcntrl_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswdigit_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswgraph_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswlower_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswprint_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswpunct_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswspace_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswupper_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswxdigit_l( wint_t _C, _locale_t _Locale); int __cdecl _iswcsymf_l ( wint_t _C, _locale_t _Locale); int __cdecl _iswcsym_l ( wint_t _C, _locale_t _Locale); wint_t __cdecl towupper( wint_t _C); wint_t __cdecl towlower( wint_t _C); int __cdecl iswctype( wint_t _C, wctype_t _Type); wint_t __cdecl _towupper_l( wint_t _C, _locale_t _Locale); wint_t __cdecl _towlower_l( wint_t _C, _locale_t _Locale); int __cdecl _iswctype_l( wint_t _C, wctype_t _Type, _locale_t _Locale); int __cdecl isleadbyte( int _C); int __cdecl _isleadbyte_l( int _C, _locale_t _Locale); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "iswctype" " " "instead. See online help for details.")) int __cdecl is_wctype( wint_t _C, wctype_t _Type); #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wctype.h" #line 150 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wctype.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\ctype.h" __pragma(pack(push, 8)) int __cdecl _isctype( int _C, int _Type); int __cdecl _isctype_l( int _C, int _Type, _locale_t _Locale); int __cdecl isalpha( int _C); int __cdecl _isalpha_l( int _C, _locale_t _Locale); int __cdecl isupper( int _C); int __cdecl _isupper_l( int _C, _locale_t _Locale); int __cdecl islower( int _C); int __cdecl _islower_l( int _C, _locale_t _Locale); int __cdecl isdigit( int _C); int __cdecl _isdigit_l( int _C, _locale_t _Locale); int __cdecl isxdigit( int _C); int __cdecl _isxdigit_l( int _C, _locale_t _Locale); int __cdecl isspace( int _C); int __cdecl _isspace_l( int _C, _locale_t _Locale); int __cdecl ispunct( int _C); int __cdecl _ispunct_l( int _C, _locale_t _Locale); int __cdecl isblank( int _C); int __cdecl _isblank_l( int _C, _locale_t _Locale); int __cdecl isalnum( int _C); int __cdecl _isalnum_l( int _C, _locale_t _Locale); int __cdecl isprint( int _C); int __cdecl _isprint_l( int _C, _locale_t _Locale); int __cdecl isgraph( int _C); int __cdecl _isgraph_l( int _C, _locale_t _Locale); int __cdecl iscntrl( int _C); int __cdecl _iscntrl_l( int _C, _locale_t _Locale); int __cdecl toupper( int _C); int __cdecl tolower( int _C); int __cdecl _tolower( int _C); int __cdecl _tolower_l( int _C, _locale_t _Locale); int __cdecl _toupper( int _C); int __cdecl _toupper_l( int _C, _locale_t _Locale); int __cdecl __isascii( int _C); int __cdecl __toascii( int _C); int __cdecl __iscsymf( int _C); int __cdecl __iscsym( int _C); #line 91 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\ctype.h" int __cdecl ___mb_cur_max_func(void); int __cdecl ___mb_cur_max_l_func(_locale_t _Locale); #line 116 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\ctype.h" #line 127 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\ctype.h" #line 144 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\ctype.h" __inline __crt_locale_data_public* __cdecl __acrt_get_locale_data_prefix(void const volatile* const _LocalePointers) { _locale_t const _TypedLocalePointers = (_locale_t)_LocalePointers; return (__crt_locale_data_public*)_TypedLocalePointers->locinfo; } __inline int __cdecl _chvalidchk_l( int const _C, int const _Mask, _locale_t const _Locale ) { if (_Locale) { return __acrt_get_locale_data_prefix(_Locale)->_locale_pctype[(unsigned char)_C] & _Mask; } return (__pctype_func()[(unsigned char)(_C)] & (_Mask)); } __inline int __cdecl _ischartype_l( int const _C, int const _Mask, _locale_t const _Locale ) { if (_Locale && __acrt_get_locale_data_prefix(_Locale)->_locale_mb_cur_max > 1) { return _isctype_l(_C, _Mask, _Locale); } return _chvalidchk_l(_C, _Mask, _Locale); } #line 202 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\ctype.h" #line 230 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\ctype.h" __pragma(pack(pop)) #line 35 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 64 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 82 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\kernelspecs.h" #pragma once #line 69 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\kernelspecs.h" #line 257 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\kernelspecs.h" #line 87 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 113 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 124 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 138 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 156 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\basetsd.h" #pragma warning(push) #pragma warning(disable:4668) typedef unsigned __int64 POINTER_64_INT; #line 49 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\basetsd.h" #line 63 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\basetsd.h" #pragma once typedef signed char INT8, *PINT8; typedef signed short INT16, *PINT16; typedef signed int INT32, *PINT32; typedef signed __int64 INT64, *PINT64; typedef unsigned char UINT8, *PUINT8; typedef unsigned short UINT16, *PUINT16; typedef unsigned int UINT32, *PUINT32; typedef unsigned __int64 UINT64, *PUINT64; typedef signed int LONG32, *PLONG32; typedef unsigned int ULONG32, *PULONG32; typedef unsigned int DWORD32, *PDWORD32; #line 104 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\basetsd.h" #line 122 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\basetsd.h" typedef __int64 INT_PTR, *PINT_PTR; typedef unsigned __int64 UINT_PTR, *PUINT_PTR; typedef __int64 LONG_PTR, *PLONG_PTR; typedef unsigned __int64 ULONG_PTR, *PULONG_PTR; #line 144 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\basetsd.h" typedef __int64 SHANDLE_PTR; typedef unsigned __int64 HANDLE_PTR; typedef unsigned int UHALF_PTR, *PUHALF_PTR; typedef int HALF_PTR, *PHALF_PTR; __inline unsigned long HandleToULong( const void *h ) { return((unsigned long) (ULONG_PTR) h ); } __inline long HandleToLong( const void *h ) { return((long) (LONG_PTR) h ); } __inline void * ULongToHandle( const unsigned long h ) { return((void *) (UINT_PTR) h ); } __inline void * LongToHandle( const long h ) { return((void *) (INT_PTR) h ); } __inline unsigned long PtrToUlong( const void *p ) { return((unsigned long) (ULONG_PTR) p ); } __inline unsigned int PtrToUint( const void *p ) { return((unsigned int) (UINT_PTR) p ); } __inline unsigned short PtrToUshort( const void *p ) { return((unsigned short) (unsigned long) (ULONG_PTR) p ); } __inline long PtrToLong( const void *p ) { return((long) (LONG_PTR) p ); } __inline int PtrToInt( const void *p ) { return((int) (INT_PTR) p ); } __inline short PtrToShort( const void *p ) { return((short) (long) (LONG_PTR) p ); } __inline void * IntToPtr( const int i ) { return( (void *)(INT_PTR)i ); } __inline void * UIntToPtr( const unsigned int ui ) { return( (void *)(UINT_PTR)ui ); } __inline void * LongToPtr( const long l ) { return( (void *)(LONG_PTR)l ); } __inline void * ULongToPtr( const unsigned long ul ) { return( (void *)(ULONG_PTR)ul ); } __inline void * Ptr32ToPtr( const void * __ptr32 p ) { return((void *) (ULONG_PTR) (unsigned long) p); } __inline void * Handle32ToHandle( const void * __ptr32 h ) { return((void *) (LONG_PTR) (long) h); } __inline void * __ptr32 PtrToPtr32( const void *p ) { return((void * __ptr32) (unsigned long) (ULONG_PTR) p); } #line 397 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\basetsd.h" typedef ULONG_PTR SIZE_T, *PSIZE_T; typedef LONG_PTR SSIZE_T, *PSSIZE_T; typedef ULONG_PTR DWORD_PTR, *PDWORD_PTR; typedef __int64 LONG64, *PLONG64; typedef unsigned __int64 ULONG64, *PULONG64; typedef unsigned __int64 DWORD64, *PDWORD64; typedef ULONG_PTR KAFFINITY; typedef KAFFINITY *PKAFFINITY; #pragma warning(pop) #line 180 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 189 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 197 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 205 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 213 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 223 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 235 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 243 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 251 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 259 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 267 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 275 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 283 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 291 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 300 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 308 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 316 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 324 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 334 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 367 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 382 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef void *PVOID; typedef void * __ptr64 PVOID64; #line 400 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 423 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef char CHAR; typedef short SHORT; typedef long LONG; typedef int INT; typedef wchar_t WCHAR; typedef WCHAR *PWCHAR, *LPWCH, *PWCH; typedef const WCHAR *LPCWCH, *PCWCH; typedef WCHAR *NWPSTR, *LPWSTR, *PWSTR; typedef PWSTR *PZPWSTR; typedef const PWSTR *PCZPWSTR; typedef WCHAR __unaligned *LPUWSTR, *PUWSTR; typedef const WCHAR *LPCWSTR, *PCWSTR; typedef PCWSTR *PZPCWSTR; typedef const PCWSTR *PCZPCWSTR; typedef const WCHAR __unaligned *LPCUWSTR, *PCUWSTR; typedef WCHAR *PZZWSTR; typedef const WCHAR *PCZZWSTR; typedef WCHAR __unaligned *PUZZWSTR; typedef const WCHAR __unaligned *PCUZZWSTR; typedef WCHAR *PNZWCH; typedef const WCHAR *PCNZWCH; typedef WCHAR __unaligned *PUNZWCH; typedef const WCHAR __unaligned *PCUNZWCH; typedef const WCHAR *LPCWCHAR, *PCWCHAR; typedef const WCHAR __unaligned *LPCUWCHAR, *PCUWCHAR; typedef unsigned long UCSCHAR; typedef UCSCHAR *PUCSCHAR; typedef const UCSCHAR *PCUCSCHAR; typedef UCSCHAR *PUCSSTR; typedef UCSCHAR __unaligned *PUUCSSTR; typedef const UCSCHAR *PCUCSSTR; typedef const UCSCHAR __unaligned *PCUUCSSTR; typedef UCSCHAR __unaligned *PUUCSCHAR; typedef const UCSCHAR __unaligned *PCUUCSCHAR; typedef CHAR *PCHAR, *LPCH, *PCH; typedef const CHAR *LPCCH, *PCCH; typedef CHAR *NPSTR, *LPSTR, *PSTR; typedef PSTR *PZPSTR; typedef const PSTR *PCZPSTR; typedef const CHAR *LPCSTR, *PCSTR; typedef PCSTR *PZPCSTR; typedef const PCSTR *PCZPCSTR; typedef CHAR *PZZSTR; typedef const CHAR *PCZZSTR; typedef CHAR *PNZCH; typedef const CHAR *PCNZCH; #line 565 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef char TCHAR, *PTCHAR; typedef unsigned char TBYTE , *PTBYTE ; typedef LPCH LPTCH, PTCH; typedef LPCCH LPCTCH, PCTCH; typedef LPSTR PTSTR, LPTSTR, PUTSTR, LPUTSTR; typedef LPCSTR PCTSTR, LPCTSTR, PCUTSTR, LPCUTSTR; typedef PZZSTR PZZTSTR, PUZZTSTR; typedef PCZZSTR PCZZTSTR, PCUZZTSTR; typedef PZPSTR PZPTSTR; typedef PNZCH PNZTCH, PUNZTCH; typedef PCNZCH PCNZTCH, PCUNZTCH; typedef SHORT *PSHORT; typedef LONG *PLONG; typedef struct _PROCESSOR_NUMBER { WORD Group; BYTE Number; BYTE Reserved; } PROCESSOR_NUMBER, *PPROCESSOR_NUMBER; typedef struct _GROUP_AFFINITY { KAFFINITY Mask; WORD Group; WORD Reserved[3]; } GROUP_AFFINITY, *PGROUP_AFFINITY; typedef void *HANDLE; #line 643 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef HANDLE *PHANDLE; typedef BYTE FCHAR; typedef WORD FSHORT; typedef DWORD FLONG; typedef long HRESULT; #line 679 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 690 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 703 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef char CCHAR; typedef DWORD LCID; typedef PDWORD PLCID; typedef WORD LANGID; typedef enum { UNSPECIFIED_COMPARTMENT_ID = 0, DEFAULT_COMPARTMENT_ID } COMPARTMENT_ID, *PCOMPARTMENT_ID; typedef struct _FLOAT128 { __int64 LowPart; __int64 HighPart; } FLOAT128; typedef FLOAT128 *PFLOAT128; typedef __int64 LONGLONG; typedef unsigned __int64 ULONGLONG; #line 810 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef LONGLONG *PLONGLONG; typedef ULONGLONG *PULONGLONG; typedef LONGLONG USN; typedef union _LARGE_INTEGER { struct { DWORD LowPart; LONG HighPart; } ; struct { DWORD LowPart; LONG HighPart; } u; LONGLONG QuadPart; } LARGE_INTEGER; typedef LARGE_INTEGER *PLARGE_INTEGER; typedef union _ULARGE_INTEGER { struct { DWORD LowPart; DWORD HighPart; } ; struct { DWORD LowPart; DWORD HighPart; } u; ULONGLONG QuadPart; } ULARGE_INTEGER; typedef ULARGE_INTEGER *PULARGE_INTEGER; typedef LONG_PTR RTL_REFERENCE_COUNT, *PRTL_REFERENCE_COUNT; typedef LONG RTL_REFERENCE_COUNT32, *PRTL_REFERENCE_COUNT32; typedef struct _LUID { DWORD LowPart; LONG HighPart; } LUID, *PLUID; typedef ULONGLONG DWORDLONG; typedef DWORDLONG *PDWORDLONG; #line 1011 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" unsigned char __cdecl _rotl8 ( unsigned char Value, unsigned char Shift ); unsigned short __cdecl _rotl16 ( unsigned short Value, unsigned char Shift ); unsigned char __cdecl _rotr8 ( unsigned char Value, unsigned char Shift ); unsigned short __cdecl _rotr16 ( unsigned short Value, unsigned char Shift ); #pragma intrinsic(_rotl8) #pragma intrinsic(_rotl16) #pragma intrinsic(_rotr8) #pragma intrinsic(_rotr16) unsigned int __cdecl _rotl ( unsigned int Value, int Shift ); unsigned __int64 __cdecl _rotl64 ( unsigned __int64 Value, int Shift ); unsigned int __cdecl _rotr ( unsigned int Value, int Shift ); unsigned __int64 __cdecl _rotr64 ( unsigned __int64 Value, int Shift ); #pragma intrinsic(_rotl) #pragma intrinsic(_rotl64) #pragma intrinsic(_rotr) #pragma intrinsic(_rotr64) typedef BYTE BOOLEAN; typedef BOOLEAN *PBOOLEAN; typedef struct _LIST_ENTRY { struct _LIST_ENTRY *Flink; struct _LIST_ENTRY *Blink; } LIST_ENTRY, *PLIST_ENTRY, * PRLIST_ENTRY; typedef struct _SINGLE_LIST_ENTRY { struct _SINGLE_LIST_ENTRY *Next; } SINGLE_LIST_ENTRY, *PSINGLE_LIST_ENTRY; typedef struct LIST_ENTRY32 { DWORD Flink; DWORD Blink; } LIST_ENTRY32; typedef LIST_ENTRY32 *PLIST_ENTRY32; typedef struct LIST_ENTRY64 { ULONGLONG Flink; ULONGLONG Blink; } LIST_ENTRY64; typedef LIST_ENTRY64 *PLIST_ENTRY64; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" #line 22 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" typedef struct _GUID { unsigned long Data1; unsigned short Data2; unsigned short Data3; unsigned char Data4[ 8 ]; } GUID; #line 38 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" #line 54 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" #line 67 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" typedef GUID *LPGUID; typedef const GUID *LPCGUID; typedef GUID IID; typedef IID *LPIID; typedef GUID CLSID; typedef CLSID *LPCLSID; typedef GUID FMTID; typedef FMTID *LPFMTID; #line 113 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" #line 122 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" #line 131 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" #line 140 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" #pragma once __pragma(pack(push, 8)) int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); unsigned long* __cdecl __doserrno(void); errno_t __cdecl _set_doserrno( unsigned long _Value); errno_t __cdecl _get_doserrno( unsigned long * _Value); #line 70 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" #line 79 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" #line 127 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" __pragma(pack(pop)) #line 12 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime_string.h" #pragma once __pragma(pack(push, 8)) void * __cdecl memchr( void const* _Buf, int _Val, size_t _MaxCount ); int __cdecl memcmp( void const* _Buf1, void const* _Buf2, size_t _Size ); void* __cdecl memcpy( void* _Dst, void const* _Src, size_t _Size ); void* __cdecl memmove( void* _Dst, void const* _Src, size_t _Size ); void* __cdecl memset( void* _Dst, int _Val, size_t _Size ); char * __cdecl strchr( char const* _Str, int _Val ); char * __cdecl strrchr( char const* _Str, int _Ch ); char * __cdecl strstr( char const* _Str, char const* _SubStr ); wchar_t * __cdecl wcschr( wchar_t const* _Str, wchar_t _Ch ); wchar_t * __cdecl wcsrchr( wchar_t const* _Str, wchar_t _Ch ); wchar_t * __cdecl wcsstr( wchar_t const* _Str, wchar_t const* _SubStr ); __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" static __inline errno_t __cdecl memcpy_s( void* const _Destination, rsize_t const _DestinationSize, void const* const _Source, rsize_t const _SourceSize ) { if (_SourceSize == 0) { return 0; } { int _Expr_val=!!(_Destination != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; if (_Source == ((void *)0) || _DestinationSize < _SourceSize) { memset(_Destination, 0, _DestinationSize); { int _Expr_val=!!(_Source != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; { int _Expr_val=!!(_DestinationSize >= _SourceSize); if (!(_Expr_val)) { (*_errno()) = 34; _invalid_parameter_noinfo(); return 34; } }; return 22; } memcpy(_Destination, _Source, _SourceSize); return 0; } static __inline errno_t __cdecl memmove_s( void* const _Destination, rsize_t const _DestinationSize, void const* const _Source, rsize_t const _SourceSize ) { if (_SourceSize == 0) { return 0; } { int _Expr_val=!!(_Destination != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; { int _Expr_val=!!(_Source != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; { int _Expr_val=!!(_DestinationSize >= _SourceSize); if (!(_Expr_val)) { (*_errno()) = 34; _invalid_parameter_noinfo(); return 34; } }; memmove(_Destination, _Source, _SourceSize); return 0; } __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" __pragma(pack(push, 8)) int __cdecl _memicmp( void const* _Buf1, void const* _Buf2, size_t _Size ); int __cdecl _memicmp_l( void const* _Buf1, void const* _Buf2, size_t _Size, _locale_t _Locale ); #line 56 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" #line 71 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_memccpy" ". See online help for details.")) void* __cdecl memccpy( void* _Dst, void const* _Src, int _Val, size_t _Size ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_memicmp" ". See online help for details.")) int __cdecl memicmp( void const* _Buf1, void const* _Buf2, size_t _Size ); #line 111 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" #pragma once __pragma(pack(push, 8)) errno_t __cdecl wcscat_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source ); errno_t __cdecl wcscpy_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source ); errno_t __cdecl wcsncat_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source, rsize_t _MaxCount ); errno_t __cdecl wcsncpy_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source, rsize_t _MaxCount ); wchar_t* __cdecl wcstok_s( wchar_t* _String, wchar_t const* _Delimiter, wchar_t** _Context ); __declspec(allocator) wchar_t* __cdecl _wcsdup( wchar_t const* _String ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcscat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcscat( wchar_t *_Destination, wchar_t const* _Source); #pragma warning(pop) int __cdecl wcscmp( wchar_t const* _String1, wchar_t const* _String2 ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcscpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcscpy( wchar_t *_Destination, wchar_t const* _Source); #pragma warning(pop) size_t __cdecl wcscspn( wchar_t const* _String, wchar_t const* _Control ); size_t __cdecl wcslen( wchar_t const* _String ); size_t __cdecl wcsnlen( wchar_t const* _Source, size_t _MaxCount ); static __inline size_t __cdecl wcsnlen_s( wchar_t const* _Source, size_t _MaxCount ) { return (_Source == 0) ? 0 : wcsnlen(_Source, _MaxCount); } __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcsncat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcsncat( wchar_t *_Destination, wchar_t const* _Source, size_t _Count); int __cdecl wcsncmp( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcsncpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcsncpy( wchar_t *_Destination, wchar_t const* _Source, size_t _Count); wchar_t * __cdecl wcspbrk( wchar_t const* _String, wchar_t const* _Control ); size_t __cdecl wcsspn( wchar_t const* _String, wchar_t const* _Control ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstok_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcstok( wchar_t* _String, wchar_t const* _Delimiter, wchar_t** _Context ); #line 242 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" #pragma warning(push) #pragma warning(disable: 4141 4996) #pragma warning(disable: 28719 28726 28727) __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstok_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) static __inline wchar_t* __cdecl _wcstok( wchar_t* const _String, wchar_t const* const _Delimiter ) { return wcstok(_String, _Delimiter, 0); } #line 269 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" #pragma warning(pop) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcserror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcserror( int _ErrorNumber ); errno_t __cdecl _wcserror_s( wchar_t* _Buffer, size_t _SizeInWords, int _ErrorNumber ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "__wcserror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl __wcserror( wchar_t const* _String ); errno_t __cdecl __wcserror_s( wchar_t* _Buffer, size_t _SizeInWords, wchar_t const* _ErrorMessage ); int __cdecl _wcsicmp( wchar_t const* _String1, wchar_t const* _String2 ); int __cdecl _wcsicmp_l( wchar_t const* _String1, wchar_t const* _String2, _locale_t _Locale ); int __cdecl _wcsnicmp( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); int __cdecl _wcsnicmp_l( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount, _locale_t _Locale ); errno_t __cdecl _wcsnset_s( wchar_t* _Destination, size_t _SizeInWords, wchar_t _Value, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsnset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsnset( wchar_t *_String, wchar_t _Value, size_t _MaxCount); wchar_t* __cdecl _wcsrev( wchar_t* _String ); errno_t __cdecl _wcsset_s( wchar_t* _Destination, size_t _SizeInWords, wchar_t _Value ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsset( wchar_t *_String, wchar_t _Value); errno_t __cdecl _wcslwr_s( wchar_t* _String, size_t _SizeInWords ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcslwr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcslwr( wchar_t *_String); errno_t __cdecl _wcslwr_s_l( wchar_t* _String, size_t _SizeInWords, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcslwr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcslwr_l( wchar_t *_String, _locale_t _Locale); errno_t __cdecl _wcsupr_s( wchar_t* _String, size_t _Size ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsupr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsupr( wchar_t *_String); errno_t __cdecl _wcsupr_s_l( wchar_t* _String, size_t _Size, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsupr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsupr_l( wchar_t *_String, _locale_t _Locale); size_t __cdecl wcsxfrm( wchar_t* _Destination, wchar_t const* _Source, size_t _MaxCount ); size_t __cdecl _wcsxfrm_l( wchar_t* _Destination, wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale ); int __cdecl wcscoll( wchar_t const* _String1, wchar_t const* _String2 ); int __cdecl _wcscoll_l( wchar_t const* _String1, wchar_t const* _String2, _locale_t _Locale ); int __cdecl _wcsicoll( wchar_t const* _String1, wchar_t const* _String2 ); int __cdecl _wcsicoll_l( wchar_t const* _String1, wchar_t const* _String2, _locale_t _Locale ); int __cdecl _wcsncoll( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); int __cdecl _wcsncoll_l( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount, _locale_t _Locale ); int __cdecl _wcsnicoll( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); int __cdecl _wcsnicoll_l( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount, _locale_t _Locale ); #line 565 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsdup" ". See online help for details.")) wchar_t* __cdecl wcsdup( wchar_t const* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsicmp" ". See online help for details.")) int __cdecl wcsicmp( wchar_t const* _String1, wchar_t const* _String2 ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsnicmp" ". See online help for details.")) int __cdecl wcsnicmp( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsnset" ". See online help for details.")) wchar_t* __cdecl wcsnset( wchar_t* _String, wchar_t _Value, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsrev" ". See online help for details.")) wchar_t* __cdecl wcsrev( wchar_t* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsset" ". See online help for details.")) wchar_t* __cdecl wcsset( wchar_t* _String, wchar_t _Value ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcslwr" ". See online help for details.")) wchar_t* __cdecl wcslwr( wchar_t* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsupr" ". See online help for details.")) wchar_t* __cdecl wcsupr( wchar_t* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsicoll" ". See online help for details.")) int __cdecl wcsicoll( wchar_t const* _String1, wchar_t const* _String2 ); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" __pragma(pack(push, 8)) errno_t __cdecl strcpy_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source ); errno_t __cdecl strcat_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source ); errno_t __cdecl strerror_s( char* _Buffer, size_t _SizeInBytes, int _ErrorNumber); errno_t __cdecl strncat_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source, rsize_t _MaxCount ); errno_t __cdecl strncpy_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source, rsize_t _MaxCount ); char* __cdecl strtok_s( char* _String, char const* _Delimiter, char** _Context ); void* __cdecl _memccpy( void* _Dst, void const* _Src, int _Val, size_t _MaxCount ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "strcat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strcat( char *_Destination, char const* _Source); #pragma warning(pop) int __cdecl strcmp( char const* _Str1, char const* _Str2 ); int __cdecl _strcmpi( char const* _String1, char const* _String2 ); int __cdecl strcoll( char const* _String1, char const* _String2 ); int __cdecl _strcoll_l( char const* _String1, char const* _String2, _locale_t _Locale ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "strcpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strcpy( char *_Destination, char const* _Source); #pragma warning(pop) size_t __cdecl strcspn( char const* _Str, char const* _Control ); __declspec(allocator) char* __cdecl _strdup( char const* _Source ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strerror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strerror( char const* _ErrorMessage ); errno_t __cdecl _strerror_s( char* _Buffer, size_t _SizeInBytes, char const* _ErrorMessage ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strerror( int _ErrorMessage ); int __cdecl _stricmp( char const* _String1, char const* _String2 ); int __cdecl _stricoll( char const* _String1, char const* _String2 ); int __cdecl _stricoll_l( char const* _String1, char const* _String2, _locale_t _Locale ); int __cdecl _stricmp_l( char const* _String1, char const* _String2, _locale_t _Locale ); size_t __cdecl strlen( char const* _Str ); errno_t __cdecl _strlwr_s( char* _String, size_t _Size ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strlwr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strlwr( char *_String); errno_t __cdecl _strlwr_s_l( char* _String, size_t _Size, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strlwr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strlwr_l( char *_String, _locale_t _Locale); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strncat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strncat( char *_Destination, char const* _Source, size_t _Count); int __cdecl strncmp( char const* _Str1, char const* _Str2, size_t _MaxCount ); int __cdecl _strnicmp( char const* _String1, char const* _String2, size_t _MaxCount ); int __cdecl _strnicmp_l( char const* _String1, char const* _String2, size_t _MaxCount, _locale_t _Locale ); int __cdecl _strnicoll( char const* _String1, char const* _String2, size_t _MaxCount ); int __cdecl _strnicoll_l( char const* _String1, char const* _String2, size_t _MaxCount, _locale_t _Locale ); int __cdecl _strncoll( char const* _String1, char const* _String2, size_t _MaxCount ); int __cdecl _strncoll_l( char const* _String1, char const* _String2, size_t _MaxCount, _locale_t _Locale ); size_t __cdecl __strncnt( char const* _String, size_t _Count ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strncpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strncpy( char *_Destination, char const* _Source, size_t _Count); size_t __cdecl strnlen( char const* _String, size_t _MaxCount ); static __inline size_t __cdecl strnlen_s( char const* _String, size_t _MaxCount ) { return _String == 0 ? 0 : strnlen(_String, _MaxCount); } errno_t __cdecl _strnset_s( char* _String, size_t _SizeInBytes, int _Value, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strnset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strnset( char *_Destination, int _Value, size_t _Count); char * __cdecl strpbrk( char const* _Str, char const* _Control ); char* __cdecl _strrev( char* _Str ); errno_t __cdecl _strset_s( char* _Destination, size_t _DestinationSize, int _Value ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strset( char *_Destination, int _Value); size_t __cdecl strspn( char const* _Str, char const* _Control ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strtok_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strtok( char* _String, char const* _Delimiter ); errno_t __cdecl _strupr_s( char* _String, size_t _Size ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strupr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strupr( char *_String); errno_t __cdecl _strupr_s_l( char* _String, size_t _Size, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strupr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strupr_l( char *_String, _locale_t _Locale); size_t __cdecl strxfrm( char* _Destination, char const* _Source, size_t _MaxCount ); size_t __cdecl _strxfrm_l( char* _Destination, char const* _Source, size_t _MaxCount, _locale_t _Locale ); #line 528 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strdup" ". See online help for details.")) char* __cdecl strdup( char const* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strcmpi" ". See online help for details.")) int __cdecl strcmpi( char const* _String1, char const* _String2 ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_stricmp" ". See online help for details.")) int __cdecl stricmp( char const* _String1, char const* _String2 ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strlwr" ". See online help for details.")) char* __cdecl strlwr( char* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strnicmp" ". See online help for details.")) int __cdecl strnicmp( char const* _String1, char const* _String2, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strnset" ". See online help for details.")) char* __cdecl strnset( char* _String, int _Value, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strrev" ". See online help for details.")) char* __cdecl strrev( char* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strset" ". See online help for details.")) char* __cdecl strset( char* _String, int _Value); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strupr" ". See online help for details.")) char* __cdecl strupr( char* _String ); __pragma(pack(pop)) #line 147 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" #line 165 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\guiddef.h" #line 1154 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _OBJECTID { GUID Lineage; DWORD Uniquifier; } OBJECTID; #line 1173 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 1302 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef EXCEPTION_DISPOSITION __stdcall EXCEPTION_ROUTINE ( struct _EXCEPTION_RECORD *ExceptionRecord, PVOID EstablisherFrame, struct _CONTEXT *ContextRecord, PVOID DispatcherContext ); typedef EXCEPTION_ROUTINE *PEXCEPTION_ROUTINE; #line 1412 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 1577 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 1769 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 1819 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2059 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2083 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2200 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2300 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2333 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2360 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2428 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2509 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef ULONG_PTR KSPIN_LOCK; typedef KSPIN_LOCK *PKSPIN_LOCK; typedef struct __declspec(align(16)) _M128A { ULONGLONG Low; LONGLONG High; } M128A, *PM128A; typedef struct __declspec(align(16)) _XSAVE_FORMAT { WORD ControlWord; WORD StatusWord; BYTE TagWord; BYTE Reserved1; WORD ErrorOpcode; DWORD ErrorOffset; WORD ErrorSelector; WORD Reserved2; DWORD DataOffset; WORD DataSelector; WORD Reserved3; DWORD MxCsr; DWORD MxCsr_Mask; M128A FloatRegisters[8]; M128A XmmRegisters[16]; BYTE Reserved4[96]; #line 2562 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" } XSAVE_FORMAT, *PXSAVE_FORMAT; typedef struct __declspec(align(8)) _XSAVE_AREA_HEADER { DWORD64 Mask; DWORD64 CompactionMask; DWORD64 Reserved2[6]; } XSAVE_AREA_HEADER, *PXSAVE_AREA_HEADER; typedef struct __declspec(align(16)) _XSAVE_AREA { XSAVE_FORMAT LegacyState; XSAVE_AREA_HEADER Header; } XSAVE_AREA, *PXSAVE_AREA; typedef struct _XSTATE_CONTEXT { DWORD64 Mask; DWORD Length; DWORD Reserved1; PXSAVE_AREA Area; PVOID Buffer; } XSTATE_CONTEXT, *PXSTATE_CONTEXT; typedef struct _SCOPE_TABLE_AMD64 { DWORD Count; struct { DWORD BeginAddress; DWORD EndAddress; DWORD HandlerAddress; DWORD JumpTarget; } ScopeRecord[1]; } SCOPE_TABLE_AMD64, *PSCOPE_TABLE_AMD64; #line 2637 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2650 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" BOOLEAN _bittest ( LONG const *Base, LONG Offset ); BOOLEAN _bittestandcomplement ( LONG *Base, LONG Offset ); BOOLEAN _bittestandset ( LONG *Base, LONG Offset ); BOOLEAN _bittestandreset ( LONG *Base, LONG Offset ); BOOLEAN _interlockedbittestandset ( LONG volatile *Base, LONG Offset ); BOOLEAN _interlockedbittestandreset ( LONG volatile *Base, LONG Offset ); BOOLEAN _bittest64 ( LONG64 const *Base, LONG64 Offset ); BOOLEAN _bittestandcomplement64 ( LONG64 *Base, LONG64 Offset ); BOOLEAN _bittestandset64 ( LONG64 *Base, LONG64 Offset ); BOOLEAN _bittestandreset64 ( LONG64 *Base, LONG64 Offset ); BOOLEAN _interlockedbittestandset64 ( LONG64 volatile *Base, LONG64 Offset ); BOOLEAN _interlockedbittestandreset64 ( LONG64 volatile *Base, LONG64 Offset ); #pragma intrinsic(_bittest) #pragma intrinsic(_bittestandcomplement) #pragma intrinsic(_bittestandset) #pragma intrinsic(_bittestandreset) #pragma intrinsic(_interlockedbittestandset) #pragma intrinsic(_interlockedbittestandreset) #pragma intrinsic(_bittest64) #pragma intrinsic(_bittestandcomplement64) #pragma intrinsic(_bittestandset64) #pragma intrinsic(_bittestandreset64) #pragma intrinsic(_interlockedbittestandset64) #pragma intrinsic(_interlockedbittestandreset64) BOOLEAN _BitScanForward ( DWORD *Index, DWORD Mask ); BOOLEAN _BitScanReverse ( DWORD *Index, DWORD Mask ); BOOLEAN _BitScanForward64 ( DWORD *Index, DWORD64 Mask ); BOOLEAN _BitScanReverse64 ( DWORD *Index, DWORD64 Mask ); #pragma intrinsic(_BitScanForward) #pragma intrinsic(_BitScanReverse) #pragma intrinsic(_BitScanForward64) #pragma intrinsic(_BitScanReverse64) #line 2796 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2832 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2871 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2879 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 2887 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" SHORT _InterlockedIncrement16 ( SHORT volatile *Addend ); SHORT _InterlockedDecrement16 ( SHORT volatile *Addend ); SHORT _InterlockedCompareExchange16 ( SHORT volatile *Destination, SHORT ExChange, SHORT Comperand ); LONG _InterlockedAnd ( LONG volatile *Destination, LONG Value ); LONG _InterlockedOr ( LONG volatile *Destination, LONG Value ); LONG _InterlockedXor ( LONG volatile *Destination, LONG Value ); LONG64 _InterlockedAnd64 ( LONG64 volatile *Destination, LONG64 Value ); LONG64 _InterlockedOr64 ( LONG64 volatile *Destination, LONG64 Value ); LONG64 _InterlockedXor64 ( LONG64 volatile *Destination, LONG64 Value ); LONG _InterlockedIncrement ( LONG volatile *Addend ); LONG _InterlockedDecrement ( LONG volatile *Addend ); LONG _InterlockedExchange ( LONG volatile *Target, LONG Value ); LONG _InterlockedExchangeAdd ( LONG volatile *Addend, LONG Value ); __forceinline LONG _InlineInterlockedAdd ( LONG volatile *Addend, LONG Value ) { return _InterlockedExchangeAdd(Addend, Value) + Value; } LONG _InterlockedCompareExchange ( LONG volatile *Destination, LONG ExChange, LONG Comperand ); LONG64 _InterlockedIncrement64 ( LONG64 volatile *Addend ); LONG64 _InterlockedDecrement64 ( LONG64 volatile *Addend ); LONG64 _InterlockedExchange64 ( LONG64 volatile *Target, LONG64 Value ); LONG64 _InterlockedExchangeAdd64 ( LONG64 volatile *Addend, LONG64 Value ); __forceinline LONG64 _InlineInterlockedAdd64 ( LONG64 volatile *Addend, LONG64 Value ) { return _InterlockedExchangeAdd64(Addend, Value) + Value; } LONG64 _InterlockedCompareExchange64 ( LONG64 volatile *Destination, LONG64 ExChange, LONG64 Comperand ); BOOLEAN _InterlockedCompareExchange128 ( LONG64 volatile *Destination, LONG64 ExchangeHigh, LONG64 ExchangeLow, LONG64 *ComparandResult ); PVOID _InterlockedCompareExchangePointer ( PVOID volatile *Destination, PVOID Exchange, PVOID Comperand ); PVOID _InterlockedExchangePointer( PVOID volatile *Target, PVOID Value ); #pragma intrinsic(_InterlockedIncrement16) #pragma intrinsic(_InterlockedDecrement16) #pragma intrinsic(_InterlockedCompareExchange16) #pragma intrinsic(_InterlockedAnd) #pragma intrinsic(_InterlockedOr) #pragma intrinsic(_InterlockedXor) #pragma intrinsic(_InterlockedIncrement) #pragma intrinsic(_InterlockedDecrement) #pragma intrinsic(_InterlockedExchange) #pragma intrinsic(_InterlockedExchangeAdd) #pragma intrinsic(_InterlockedCompareExchange) #pragma intrinsic(_InterlockedAnd64) #pragma intrinsic(_InterlockedOr64) #pragma intrinsic(_InterlockedXor64) #pragma intrinsic(_InterlockedIncrement64) #pragma intrinsic(_InterlockedDecrement64) #pragma intrinsic(_InterlockedExchange64) #pragma intrinsic(_InterlockedExchangeAdd64) #pragma intrinsic(_InterlockedCompareExchange64) #pragma intrinsic(_InterlockedCompareExchange128) #pragma intrinsic(_InterlockedExchangePointer) #pragma intrinsic(_InterlockedCompareExchangePointer) CHAR _InterlockedExchange8 ( CHAR volatile *Target, CHAR Value ); SHORT _InterlockedExchange16 ( SHORT volatile *Destination, SHORT ExChange ); #pragma intrinsic(_InterlockedExchange8) #pragma intrinsic(_InterlockedExchange16) #line 3116 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" char _InterlockedExchangeAdd8 ( char volatile * _Addend, char _Value ); char _InterlockedAnd8 ( char volatile *Destination, char Value ); char _InterlockedOr8 ( char volatile *Destination, char Value ); char _InterlockedXor8 ( char volatile *Destination, char Value ); SHORT _InterlockedAnd16( SHORT volatile *Destination, SHORT Value ); SHORT _InterlockedOr16( SHORT volatile *Destination, SHORT Value ); SHORT _InterlockedXor16( SHORT volatile *Destination, SHORT Value ); #pragma intrinsic (_InterlockedExchangeAdd8) #pragma intrinsic (_InterlockedAnd8) #pragma intrinsic (_InterlockedOr8) #pragma intrinsic (_InterlockedXor8) #pragma intrinsic (_InterlockedAnd16) #pragma intrinsic (_InterlockedOr16) #pragma intrinsic (_InterlockedXor16) void __cpuidex ( int CPUInfo[4], int Function, int SubLeaf ); #pragma intrinsic(__cpuidex) void _mm_clflush ( void const *Address ); #pragma intrinsic(_mm_clflush) void _ReadWriteBarrier ( void ); #pragma intrinsic(_ReadWriteBarrier) void __faststorefence ( void ); void _mm_lfence ( void ); void _mm_mfence ( void ); void _mm_sfence ( void ); void _mm_pause ( void ); void _mm_prefetch ( CHAR const *a, int sel ); void _m_prefetchw ( volatile const void *Source ); #pragma intrinsic(__faststorefence) #pragma intrinsic(_mm_pause) #pragma intrinsic(_mm_prefetch) #pragma intrinsic(_mm_lfence) #pragma intrinsic(_mm_mfence) #pragma intrinsic(_mm_sfence) #pragma intrinsic(_m_prefetchw) unsigned int _mm_getcsr ( void ); void _mm_setcsr ( unsigned int MxCsr ); #pragma intrinsic(_mm_getcsr) #pragma intrinsic(_mm_setcsr) unsigned __int32 __getcallerseflags ( void ); #pragma intrinsic(__getcallerseflags) DWORD __segmentlimit ( DWORD Selector ); #pragma intrinsic(__segmentlimit) DWORD64 __readpmc ( DWORD Counter ); #pragma intrinsic(__readpmc) DWORD64 __rdtsc ( void ); #pragma intrinsic(__rdtsc) void __movsb ( PBYTE Destination, BYTE const *Source, SIZE_T Count ); void __movsw ( PWORD Destination, WORD const *Source, SIZE_T Count ); void __movsd ( PDWORD Destination, DWORD const *Source, SIZE_T Count ); void __movsq ( PDWORD64 Destination, DWORD64 const *Source, SIZE_T Count ); #pragma intrinsic(__movsb) #pragma intrinsic(__movsw) #pragma intrinsic(__movsd) #pragma intrinsic(__movsq) void __stosb ( PBYTE Destination, BYTE Value, SIZE_T Count ); void __stosw ( PWORD Destination, WORD Value, SIZE_T Count ); void __stosd ( PDWORD Destination, DWORD Value, SIZE_T Count ); void __stosq ( PDWORD64 Destination, DWORD64 Value, SIZE_T Count ); #pragma intrinsic(__stosb) #pragma intrinsic(__stosw) #pragma intrinsic(__stosd) #pragma intrinsic(__stosq) LONGLONG __mulh ( LONG64 Multiplier, LONG64 Multiplicand ); ULONGLONG __umulh ( DWORD64 Multiplier, DWORD64 Multiplicand ); #pragma intrinsic(__mulh) #pragma intrinsic(__umulh) DWORD64 __popcnt64 ( DWORD64 operand ); #pragma intrinsic(__popcnt64) DWORD64 __shiftleft128 ( DWORD64 LowPart, DWORD64 HighPart, BYTE Shift ); DWORD64 __shiftright128 ( DWORD64 LowPart, DWORD64 HighPart, BYTE Shift ); #pragma intrinsic(__shiftleft128) #pragma intrinsic(__shiftright128) LONG64 _mul128 ( LONG64 Multiplier, LONG64 Multiplicand, LONG64 *HighProduct ); #pragma intrinsic(_mul128) DWORD64 _umul128 ( DWORD64 Multiplier, DWORD64 Multiplicand, DWORD64 *HighProduct ); #pragma intrinsic(_umul128) __forceinline LONG64 MultiplyExtract128 ( LONG64 Multiplier, LONG64 Multiplicand, BYTE Shift ) { LONG64 extractedProduct; LONG64 highProduct; LONG64 lowProduct; BOOLEAN negate; DWORD64 uhighProduct; DWORD64 ulowProduct; lowProduct = _mul128(Multiplier, Multiplicand, &highProduct); negate = 0; uhighProduct = (DWORD64)highProduct; ulowProduct = (DWORD64)lowProduct; if (highProduct < 0) { negate = 1; uhighProduct = (DWORD64)(-highProduct); ulowProduct = (DWORD64)(-lowProduct); if (ulowProduct != 0) { uhighProduct -= 1; } } extractedProduct = (LONG64)__shiftright128(ulowProduct, uhighProduct, Shift); if (negate != 0) { extractedProduct = -extractedProduct; } return extractedProduct; } __forceinline DWORD64 UnsignedMultiplyExtract128 ( DWORD64 Multiplier, DWORD64 Multiplicand, BYTE Shift ) { DWORD64 extractedProduct; DWORD64 highProduct; DWORD64 lowProduct; lowProduct = _umul128(Multiplier, Multiplicand, &highProduct); extractedProduct = __shiftright128(lowProduct, highProduct, Shift); return extractedProduct; } BYTE __readgsbyte ( DWORD Offset ); WORD __readgsword ( DWORD Offset ); DWORD __readgsdword ( DWORD Offset ); DWORD64 __readgsqword ( DWORD Offset ); void __writegsbyte ( DWORD Offset, BYTE Data ); void __writegsword ( DWORD Offset, WORD Data ); void __writegsdword ( DWORD Offset, DWORD Data ); void __writegsqword ( DWORD Offset, DWORD64 Data ); #pragma intrinsic(__readgsbyte) #pragma intrinsic(__readgsword) #pragma intrinsic(__readgsdword) #pragma intrinsic(__readgsqword) #pragma intrinsic(__writegsbyte) #pragma intrinsic(__writegsword) #pragma intrinsic(__writegsdword) #pragma intrinsic(__writegsqword) void __incgsbyte ( DWORD Offset ); void __addgsbyte ( DWORD Offset, BYTE Value ); void __incgsword ( DWORD Offset ); void __addgsword ( DWORD Offset, WORD Value ); void __incgsdword ( DWORD Offset ); void __addgsdword ( DWORD Offset, DWORD Value ); void __incgsqword ( DWORD Offset ); void __addgsqword ( DWORD Offset, DWORD64 Value ); #line 3714 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef XSAVE_FORMAT XMM_SAVE_AREA32, *PXMM_SAVE_AREA32; typedef struct __declspec(align(16)) _CONTEXT { DWORD64 P1Home; DWORD64 P2Home; DWORD64 P3Home; DWORD64 P4Home; DWORD64 P5Home; DWORD64 P6Home; DWORD ContextFlags; DWORD MxCsr; WORD SegCs; WORD SegDs; WORD SegEs; WORD SegFs; WORD SegGs; WORD SegSs; DWORD EFlags; DWORD64 Dr0; DWORD64 Dr1; DWORD64 Dr2; DWORD64 Dr3; DWORD64 Dr6; DWORD64 Dr7; DWORD64 Rax; DWORD64 Rcx; DWORD64 Rdx; DWORD64 Rbx; DWORD64 Rsp; DWORD64 Rbp; DWORD64 Rsi; DWORD64 Rdi; DWORD64 R8; DWORD64 R9; DWORD64 R10; DWORD64 R11; DWORD64 R12; DWORD64 R13; DWORD64 R14; DWORD64 R15; DWORD64 Rip; union { XMM_SAVE_AREA32 FltSave; struct { M128A Header[2]; M128A Legacy[8]; M128A Xmm0; M128A Xmm1; M128A Xmm2; M128A Xmm3; M128A Xmm4; M128A Xmm5; M128A Xmm6; M128A Xmm7; M128A Xmm8; M128A Xmm9; M128A Xmm10; M128A Xmm11; M128A Xmm12; M128A Xmm13; M128A Xmm14; M128A Xmm15; } ; } ; M128A VectorRegister[26]; DWORD64 VectorControl; DWORD64 DebugControl; DWORD64 LastBranchToRip; DWORD64 LastBranchFromRip; DWORD64 LastExceptionToRip; DWORD64 LastExceptionFromRip; } CONTEXT, *PCONTEXT; typedef struct _IMAGE_RUNTIME_FUNCTION_ENTRY RUNTIME_FUNCTION, *PRUNTIME_FUNCTION; typedef SCOPE_TABLE_AMD64 SCOPE_TABLE, *PSCOPE_TABLE; typedef struct _UNWIND_HISTORY_TABLE_ENTRY { DWORD64 ImageBase; PRUNTIME_FUNCTION FunctionEntry; } UNWIND_HISTORY_TABLE_ENTRY, *PUNWIND_HISTORY_TABLE_ENTRY; typedef struct _UNWIND_HISTORY_TABLE { DWORD Count; BYTE LocalHint; BYTE GlobalHint; BYTE Search; BYTE Once; DWORD64 LowAddress; DWORD64 HighAddress; UNWIND_HISTORY_TABLE_ENTRY Entry[12]; } UNWIND_HISTORY_TABLE, *PUNWIND_HISTORY_TABLE; typedef PRUNTIME_FUNCTION GET_RUNTIME_FUNCTION_CALLBACK ( DWORD64 ControlPc, PVOID Context ); typedef GET_RUNTIME_FUNCTION_CALLBACK *PGET_RUNTIME_FUNCTION_CALLBACK; typedef DWORD OUT_OF_PROCESS_FUNCTION_TABLE_CALLBACK ( HANDLE Process, PVOID TableAddress, PDWORD Entries, PRUNTIME_FUNCTION* Functions ); typedef OUT_OF_PROCESS_FUNCTION_TABLE_CALLBACK *POUT_OF_PROCESS_FUNCTION_TABLE_CALLBACK; typedef struct _DISPATCHER_CONTEXT { DWORD64 ControlPc; DWORD64 ImageBase; PRUNTIME_FUNCTION FunctionEntry; DWORD64 EstablisherFrame; DWORD64 TargetIp; PCONTEXT ContextRecord; PEXCEPTION_ROUTINE LanguageHandler; PVOID HandlerData; PUNWIND_HISTORY_TABLE HistoryTable; DWORD ScopeIndex; DWORD Fill0; } DISPATCHER_CONTEXT, *PDISPATCHER_CONTEXT; struct _EXCEPTION_POINTERS; typedef LONG (*PEXCEPTION_FILTER) ( struct _EXCEPTION_POINTERS *ExceptionPointers, PVOID EstablisherFrame ); typedef void (*PTERMINATION_HANDLER) ( BOOLEAN _abnormal_termination, PVOID EstablisherFrame ); typedef struct _KNONVOLATILE_CONTEXT_POINTERS { union { PM128A FloatingContext[16]; struct { PM128A Xmm0; PM128A Xmm1; PM128A Xmm2; PM128A Xmm3; PM128A Xmm4; PM128A Xmm5; PM128A Xmm6; PM128A Xmm7; PM128A Xmm8; PM128A Xmm9; PM128A Xmm10; PM128A Xmm11; PM128A Xmm12; PM128A Xmm13; PM128A Xmm14; PM128A Xmm15; } ; } ; union { PDWORD64 IntegerContext[16]; struct { PDWORD64 Rax; PDWORD64 Rcx; PDWORD64 Rdx; PDWORD64 Rbx; PDWORD64 Rsp; PDWORD64 Rbp; PDWORD64 Rsi; PDWORD64 Rdi; PDWORD64 R8; PDWORD64 R9; PDWORD64 R10; PDWORD64 R11; PDWORD64 R12; PDWORD64 R13; PDWORD64 R14; PDWORD64 R15; } ; } ; } KNONVOLATILE_CONTEXT_POINTERS, *PKNONVOLATILE_CONTEXT_POINTERS; typedef struct _SCOPE_TABLE_ARM { DWORD Count; struct { DWORD BeginAddress; DWORD EndAddress; DWORD HandlerAddress; DWORD JumpTarget; } ScopeRecord[1]; } SCOPE_TABLE_ARM, *PSCOPE_TABLE_ARM; #line 5075 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _SCOPE_TABLE_ARM64 { DWORD Count; struct { DWORD BeginAddress; DWORD EndAddress; DWORD HandlerAddress; DWORD JumpTarget; } ScopeRecord[1]; } SCOPE_TABLE_ARM64, *PSCOPE_TABLE_ARM64; #line 6260 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _KNONVOLATILE_CONTEXT_POINTERS_ARM64 { PDWORD64 X19; PDWORD64 X20; PDWORD64 X21; PDWORD64 X22; PDWORD64 X23; PDWORD64 X24; PDWORD64 X25; PDWORD64 X26; PDWORD64 X27; PDWORD64 X28; PDWORD64 Fp; PDWORD64 Lr; PDWORD64 D8; PDWORD64 D9; PDWORD64 D10; PDWORD64 D11; PDWORD64 D12; PDWORD64 D13; PDWORD64 D14; PDWORD64 D15; } KNONVOLATILE_CONTEXT_POINTERS_ARM64, *PKNONVOLATILE_CONTEXT_POINTERS_ARM64; #line 6311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 6336 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" void __int2c ( void ); #pragma intrinsic(__int2c) #line 6463 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 7628 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _LDT_ENTRY { WORD LimitLow; WORD BaseLow; union { struct { BYTE BaseMid; BYTE Flags1; BYTE Flags2; BYTE BaseHi; } Bytes; struct { DWORD BaseMid : 8; DWORD Type : 5; DWORD Dpl : 2; DWORD Pres : 1; DWORD LimitHi : 4; DWORD Sys : 1; DWORD Reserved_0 : 1; DWORD Default_Big : 1; DWORD Granularity : 1; DWORD BaseHi : 8; } Bits; } HighWord; } LDT_ENTRY, *PLDT_ENTRY; __forceinline CHAR ReadAcquire8 ( CHAR const volatile *Source ) { CHAR Value; Value = *Source; return Value; } __forceinline CHAR ReadNoFence8 ( CHAR const volatile *Source ) { CHAR Value; Value = *Source; return Value; } __forceinline void WriteRelease8 ( CHAR volatile *Destination, CHAR Value ) { *Destination = Value; return; } __forceinline void WriteNoFence8 ( CHAR volatile *Destination, CHAR Value ) { *Destination = Value; return; } __forceinline SHORT ReadAcquire16 ( SHORT const volatile *Source ) { SHORT Value; Value = *Source; return Value; } __forceinline SHORT ReadNoFence16 ( SHORT const volatile *Source ) { SHORT Value; Value = *Source; return Value; } __forceinline void WriteRelease16 ( SHORT volatile *Destination, SHORT Value ) { *Destination = Value; return; } __forceinline void WriteNoFence16 ( SHORT volatile *Destination, SHORT Value ) { *Destination = Value; return; } __forceinline LONG ReadAcquire ( LONG const volatile *Source ) { LONG Value; Value = *Source; return Value; } __forceinline LONG ReadNoFence ( LONG const volatile *Source ) { LONG Value; Value = *Source; return Value; } __forceinline void WriteRelease ( LONG volatile *Destination, LONG Value ) { *Destination = Value; return; } __forceinline void WriteNoFence ( LONG volatile *Destination, LONG Value ) { *Destination = Value; return; } __forceinline LONG64 ReadAcquire64 ( LONG64 const volatile *Source ) { LONG64 Value; Value = *Source; return Value; } __forceinline LONG64 ReadNoFence64 ( LONG64 const volatile *Source ) { LONG64 Value; Value = *Source; return Value; } __forceinline void WriteRelease64 ( LONG64 volatile *Destination, LONG64 Value ) { *Destination = Value; return; } __forceinline void WriteNoFence64 ( LONG64 volatile *Destination, LONG64 Value ) { *Destination = Value; return; } __forceinline CHAR ReadRaw8 ( CHAR const volatile *Source ) { CHAR Value; Value = *(CHAR *)Source; return Value; } __forceinline void WriteRaw8 ( CHAR volatile *Destination, CHAR Value ) { *(CHAR *)Destination = Value; return; } __forceinline SHORT ReadRaw16 ( SHORT const volatile *Source ) { SHORT Value; Value = *(SHORT *)Source; return Value; } __forceinline void WriteRaw16 ( SHORT volatile *Destination, SHORT Value ) { *(SHORT *)Destination = Value; return; } __forceinline LONG ReadRaw ( LONG const volatile *Source ) { LONG Value; Value = *(LONG *)Source; return Value; } __forceinline void WriteRaw ( LONG volatile *Destination, LONG Value ) { *(LONG *)Destination = Value; return; } __forceinline LONG64 ReadRaw64 ( LONG64 const volatile *Source ) { LONG64 Value; Value = *(LONG64 *)Source; return Value; } __forceinline void WriteRaw64 ( LONG64 volatile *Destination, LONG64 Value ) { *(LONG64 *)Destination = Value; return; } __forceinline BYTE ReadUCharAcquire ( BYTE const volatile *Source ) { return (BYTE )ReadAcquire8((PCHAR)Source); } __forceinline BYTE ReadUCharNoFence ( BYTE const volatile *Source ) { return (BYTE )ReadNoFence8((PCHAR)Source); } __forceinline BYTE ReadBooleanAcquire ( BOOLEAN const volatile *Source ) { return (BOOLEAN)ReadAcquire8((PCHAR)Source); } __forceinline BYTE ReadBooleanNoFence ( BOOLEAN const volatile *Source ) { return (BOOLEAN)ReadNoFence8((PCHAR)Source); } __forceinline BYTE ReadUCharRaw ( BYTE const volatile *Source ) { return (BYTE )ReadRaw8((PCHAR)Source); } __forceinline void WriteUCharRelease ( BYTE volatile *Destination, BYTE Value ) { WriteRelease8((PCHAR)Destination, (CHAR)Value); return; } __forceinline void WriteUCharNoFence ( BYTE volatile *Destination, BYTE Value ) { WriteNoFence8((PCHAR)Destination, (CHAR)Value); return; } __forceinline void WriteBooleanRelease ( BOOLEAN volatile *Destination, BOOLEAN Value ) { WriteRelease8((PCHAR)Destination, (CHAR)Value); return; } __forceinline void WriteBooleanNoFence ( BOOLEAN volatile *Destination, BOOLEAN Value ) { WriteNoFence8((PCHAR)Destination, (CHAR)Value); return; } __forceinline void WriteUCharRaw ( BYTE volatile *Destination, BYTE Value ) { WriteRaw8((PCHAR)Destination, (CHAR)Value); return; } __forceinline WORD ReadUShortAcquire ( WORD const volatile *Source ) { return (WORD )ReadAcquire16((PSHORT)Source); } __forceinline WORD ReadUShortNoFence ( WORD const volatile *Source ) { return (WORD )ReadNoFence16((PSHORT)Source); } __forceinline WORD ReadUShortRaw ( WORD const volatile *Source ) { return (WORD )ReadRaw16((PSHORT)Source); } __forceinline void WriteUShortRelease ( WORD volatile *Destination, WORD Value ) { WriteRelease16((PSHORT)Destination, (SHORT)Value); return; } __forceinline void WriteUShortNoFence ( WORD volatile *Destination, WORD Value ) { WriteNoFence16((PSHORT)Destination, (SHORT)Value); return; } __forceinline void WriteUShortRaw ( WORD volatile *Destination, WORD Value ) { WriteRaw16((PSHORT)Destination, (SHORT)Value); return; } __forceinline DWORD ReadULongAcquire ( DWORD const volatile *Source ) { return (DWORD)ReadAcquire((PLONG)Source); } __forceinline DWORD ReadULongNoFence ( DWORD const volatile *Source ) { return (DWORD)ReadNoFence((PLONG)Source); } __forceinline DWORD ReadULongRaw ( DWORD const volatile *Source ) { return (DWORD)ReadRaw((PLONG)Source); } __forceinline void WriteULongRelease ( DWORD volatile *Destination, DWORD Value ) { WriteRelease((PLONG)Destination, (LONG)Value); return; } __forceinline void WriteULongNoFence ( DWORD volatile *Destination, DWORD Value ) { WriteNoFence((PLONG)Destination, (LONG)Value); return; } __forceinline void WriteULongRaw ( DWORD volatile *Destination, DWORD Value ) { WriteRaw((PLONG)Destination, (LONG)Value); return; } __forceinline DWORD64 ReadULong64Acquire ( DWORD64 const volatile *Source ) { return (DWORD64)ReadAcquire64((PLONG64)Source); } __forceinline DWORD64 ReadULong64NoFence ( DWORD64 const volatile *Source ) { return (DWORD64)ReadNoFence64((PLONG64)Source); } __forceinline DWORD64 ReadULong64Raw ( DWORD64 const volatile *Source ) { return (DWORD64)ReadRaw64((PLONG64)Source); } __forceinline void WriteULong64Release ( DWORD64 volatile *Destination, DWORD64 Value ) { WriteRelease64((PLONG64)Destination, (LONG64)Value); return; } __forceinline void WriteULong64NoFence ( DWORD64 volatile *Destination, DWORD64 Value ) { WriteNoFence64((PLONG64)Destination, (LONG64)Value); return; } __forceinline void WriteULong64Raw ( DWORD64 volatile *Destination, DWORD64 Value ) { WriteRaw64((PLONG64)Destination, (LONG64)Value); return; } #line 8455 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" __forceinline PVOID ReadPointerAcquire ( PVOID const volatile *Source ) { return (PVOID)ReadAcquire64((PLONG64)Source); } __forceinline PVOID ReadPointerNoFence ( PVOID const volatile *Source ) { return (PVOID)ReadNoFence64((PLONG64)Source); } __forceinline PVOID ReadPointerRaw ( PVOID const volatile *Source ) { return (PVOID)ReadRaw64((PLONG64)Source); } __forceinline void WritePointerRelease ( PVOID volatile *Destination, PVOID Value ) { WriteRelease64((PLONG64)Destination, (LONG64)Value); return; } __forceinline void WritePointerNoFence ( PVOID volatile *Destination, PVOID Value ) { WriteNoFence64((PLONG64)Destination, (LONG64)Value); return; } __forceinline void WritePointerRaw ( PVOID volatile *Destination, PVOID Value ) { WriteRaw64((PLONG64)Destination, (LONG64)Value); return; } #line 8570 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _WOW64_FLOATING_SAVE_AREA { DWORD ControlWord; DWORD StatusWord; DWORD TagWord; DWORD ErrorOffset; DWORD ErrorSelector; DWORD DataOffset; DWORD DataSelector; BYTE RegisterArea[80]; DWORD Cr0NpxState; } WOW64_FLOATING_SAVE_AREA; typedef WOW64_FLOATING_SAVE_AREA *PWOW64_FLOATING_SAVE_AREA; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\pshpack4.h" #pragma warning(disable:4103) #pragma pack(push,4) #line 8609 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _WOW64_CONTEXT { DWORD ContextFlags; DWORD Dr0; DWORD Dr1; DWORD Dr2; DWORD Dr3; DWORD Dr6; DWORD Dr7; WOW64_FLOATING_SAVE_AREA FloatSave; DWORD SegGs; DWORD SegFs; DWORD SegEs; DWORD SegDs; DWORD Edi; DWORD Esi; DWORD Ebx; DWORD Edx; DWORD Ecx; DWORD Eax; DWORD Ebp; DWORD Eip; DWORD SegCs; DWORD EFlags; DWORD Esp; DWORD SegSs; BYTE ExtendedRegisters[512]; } WOW64_CONTEXT; typedef WOW64_CONTEXT *PWOW64_CONTEXT; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\poppack.h" #pragma warning(disable:4103) #pragma pack(pop) #line 8709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _WOW64_LDT_ENTRY { WORD LimitLow; WORD BaseLow; union { struct { BYTE BaseMid; BYTE Flags1; BYTE Flags2; BYTE BaseHi; } Bytes; struct { DWORD BaseMid : 8; DWORD Type : 5; DWORD Dpl : 2; DWORD Pres : 1; DWORD LimitHi : 4; DWORD Sys : 1; DWORD Reserved_0 : 1; DWORD Default_Big : 1; DWORD Granularity : 1; DWORD BaseHi : 8; } Bits; } HighWord; } WOW64_LDT_ENTRY, *PWOW64_LDT_ENTRY; typedef struct _WOW64_DESCRIPTOR_TABLE_ENTRY { DWORD Selector; WOW64_LDT_ENTRY Descriptor; } WOW64_DESCRIPTOR_TABLE_ENTRY, *PWOW64_DESCRIPTOR_TABLE_ENTRY; #line 8748 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _EXCEPTION_RECORD { DWORD ExceptionCode; DWORD ExceptionFlags; struct _EXCEPTION_RECORD *ExceptionRecord; PVOID ExceptionAddress; DWORD NumberParameters; ULONG_PTR ExceptionInformation[15]; } EXCEPTION_RECORD; typedef EXCEPTION_RECORD *PEXCEPTION_RECORD; typedef struct _EXCEPTION_RECORD32 { DWORD ExceptionCode; DWORD ExceptionFlags; DWORD ExceptionRecord; DWORD ExceptionAddress; DWORD NumberParameters; DWORD ExceptionInformation[15]; } EXCEPTION_RECORD32, *PEXCEPTION_RECORD32; typedef struct _EXCEPTION_RECORD64 { DWORD ExceptionCode; DWORD ExceptionFlags; DWORD64 ExceptionRecord; DWORD64 ExceptionAddress; DWORD NumberParameters; DWORD __unusedAlignment; DWORD64 ExceptionInformation[15]; } EXCEPTION_RECORD64, *PEXCEPTION_RECORD64; typedef struct _EXCEPTION_POINTERS { PEXCEPTION_RECORD ExceptionRecord; PCONTEXT ContextRecord; } EXCEPTION_POINTERS, *PEXCEPTION_POINTERS; #line 8819 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef PVOID PACCESS_TOKEN; typedef PVOID PSECURITY_DESCRIPTOR; typedef PVOID PSID; typedef PVOID PCLAIMS_BLOB; typedef DWORD ACCESS_MASK; typedef ACCESS_MASK *PACCESS_MASK; typedef struct _GENERIC_MAPPING { ACCESS_MASK GenericRead; ACCESS_MASK GenericWrite; ACCESS_MASK GenericExecute; ACCESS_MASK GenericAll; } GENERIC_MAPPING; typedef GENERIC_MAPPING *PGENERIC_MAPPING; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\pshpack4.h" #pragma warning(disable:4103) #pragma pack(push,4) #line 8943 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _LUID_AND_ATTRIBUTES { LUID Luid; DWORD Attributes; } LUID_AND_ATTRIBUTES, * PLUID_AND_ATTRIBUTES; typedef LUID_AND_ATTRIBUTES LUID_AND_ATTRIBUTES_ARRAY[1]; typedef LUID_AND_ATTRIBUTES_ARRAY *PLUID_AND_ATTRIBUTES_ARRAY; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\poppack.h" #pragma warning(disable:4103) #pragma pack(pop) #line 8952 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _SID_IDENTIFIER_AUTHORITY { BYTE Value[6]; } SID_IDENTIFIER_AUTHORITY, *PSID_IDENTIFIER_AUTHORITY; typedef struct _SID { BYTE Revision; BYTE SubAuthorityCount; SID_IDENTIFIER_AUTHORITY IdentifierAuthority; DWORD SubAuthority[1]; } SID, *PISID; typedef union _SE_SID { SID Sid; BYTE Buffer[(sizeof(SID) - sizeof(DWORD) + ((15) * sizeof(DWORD)))]; } SE_SID, *PSE_SID; typedef enum _SID_NAME_USE { SidTypeUser = 1, SidTypeGroup, SidTypeDomain, SidTypeAlias, SidTypeWellKnownGroup, SidTypeDeletedAccount, SidTypeInvalid, SidTypeUnknown, SidTypeComputer, SidTypeLabel, SidTypeLogonSession } SID_NAME_USE, *PSID_NAME_USE; typedef struct _SID_AND_ATTRIBUTES { PSID Sid; DWORD Attributes; } SID_AND_ATTRIBUTES, * PSID_AND_ATTRIBUTES; typedef SID_AND_ATTRIBUTES SID_AND_ATTRIBUTES_ARRAY[1]; typedef SID_AND_ATTRIBUTES_ARRAY *PSID_AND_ATTRIBUTES_ARRAY; typedef ULONG_PTR SID_HASH_ENTRY, *PSID_HASH_ENTRY; typedef struct _SID_AND_ATTRIBUTES_HASH { DWORD SidCount; PSID_AND_ATTRIBUTES SidAttr; SID_HASH_ENTRY Hash[32]; } SID_AND_ATTRIBUTES_HASH, *PSID_AND_ATTRIBUTES_HASH; #line 9100 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9185 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9320 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9339 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9360 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9376 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9400 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9415 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9439 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9457 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef enum { WinNullSid = 0, WinWorldSid = 1, WinLocalSid = 2, WinCreatorOwnerSid = 3, WinCreatorGroupSid = 4, WinCreatorOwnerServerSid = 5, WinCreatorGroupServerSid = 6, WinNtAuthoritySid = 7, WinDialupSid = 8, WinNetworkSid = 9, WinBatchSid = 10, WinInteractiveSid = 11, WinServiceSid = 12, WinAnonymousSid = 13, WinProxySid = 14, WinEnterpriseControllersSid = 15, WinSelfSid = 16, WinAuthenticatedUserSid = 17, WinRestrictedCodeSid = 18, WinTerminalServerSid = 19, WinRemoteLogonIdSid = 20, WinLogonIdsSid = 21, WinLocalSystemSid = 22, WinLocalServiceSid = 23, WinNetworkServiceSid = 24, WinBuiltinDomainSid = 25, WinBuiltinAdministratorsSid = 26, WinBuiltinUsersSid = 27, WinBuiltinGuestsSid = 28, WinBuiltinPowerUsersSid = 29, WinBuiltinAccountOperatorsSid = 30, WinBuiltinSystemOperatorsSid = 31, WinBuiltinPrintOperatorsSid = 32, WinBuiltinBackupOperatorsSid = 33, WinBuiltinReplicatorSid = 34, WinBuiltinPreWindows2000CompatibleAccessSid = 35, WinBuiltinRemoteDesktopUsersSid = 36, WinBuiltinNetworkConfigurationOperatorsSid = 37, WinAccountAdministratorSid = 38, WinAccountGuestSid = 39, WinAccountKrbtgtSid = 40, WinAccountDomainAdminsSid = 41, WinAccountDomainUsersSid = 42, WinAccountDomainGuestsSid = 43, WinAccountComputersSid = 44, WinAccountControllersSid = 45, WinAccountCertAdminsSid = 46, WinAccountSchemaAdminsSid = 47, WinAccountEnterpriseAdminsSid = 48, WinAccountPolicyAdminsSid = 49, WinAccountRasAndIasServersSid = 50, WinNTLMAuthenticationSid = 51, WinDigestAuthenticationSid = 52, WinSChannelAuthenticationSid = 53, WinThisOrganizationSid = 54, WinOtherOrganizationSid = 55, WinBuiltinIncomingForestTrustBuildersSid = 56, WinBuiltinPerfMonitoringUsersSid = 57, WinBuiltinPerfLoggingUsersSid = 58, WinBuiltinAuthorizationAccessSid = 59, WinBuiltinTerminalServerLicenseServersSid = 60, WinBuiltinDCOMUsersSid = 61, WinBuiltinIUsersSid = 62, WinIUserSid = 63, WinBuiltinCryptoOperatorsSid = 64, WinUntrustedLabelSid = 65, WinLowLabelSid = 66, WinMediumLabelSid = 67, WinHighLabelSid = 68, WinSystemLabelSid = 69, WinWriteRestrictedCodeSid = 70, WinCreatorOwnerRightsSid = 71, WinCacheablePrincipalsGroupSid = 72, WinNonCacheablePrincipalsGroupSid = 73, WinEnterpriseReadonlyControllersSid = 74, WinAccountReadonlyControllersSid = 75, WinBuiltinEventLogReadersGroup = 76, WinNewEnterpriseReadonlyControllersSid = 77, WinBuiltinCertSvcDComAccessGroup = 78, WinMediumPlusLabelSid = 79, WinLocalLogonSid = 80, WinConsoleLogonSid = 81, WinThisOrganizationCertificateSid = 82, WinApplicationPackageAuthoritySid = 83, WinBuiltinAnyPackageSid = 84, WinCapabilityInternetClientSid = 85, WinCapabilityInternetClientServerSid = 86, WinCapabilityPrivateNetworkClientServerSid = 87, WinCapabilityPicturesLibrarySid = 88, WinCapabilityVideosLibrarySid = 89, WinCapabilityMusicLibrarySid = 90, WinCapabilityDocumentsLibrarySid = 91, WinCapabilitySharedUserCertificatesSid = 92, WinCapabilityEnterpriseAuthenticationSid = 93, WinCapabilityRemovableStorageSid = 94, WinBuiltinRDSRemoteAccessServersSid = 95, WinBuiltinRDSEndpointServersSid = 96, WinBuiltinRDSManagementServersSid = 97, WinUserModeDriversSid = 98, WinBuiltinHyperVAdminsSid = 99, WinAccountCloneableControllersSid = 100, WinBuiltinAccessControlAssistanceOperatorsSid = 101, WinBuiltinRemoteManagementUsersSid = 102, WinAuthenticationAuthorityAssertedSid = 103, WinAuthenticationServiceAssertedSid = 104, WinLocalAccountSid = 105, WinLocalAccountAndAdministratorSid = 106, WinAccountProtectedUsersSid = 107, WinCapabilityAppointmentsSid = 108, WinCapabilityContactsSid = 109, WinAccountDefaultSystemManagedSid = 110, WinBuiltinDefaultSystemManagedGroupSid = 111, WinBuiltinStorageReplicaAdminsSid = 112, WinAccountKeyAdminsSid = 113, WinAccountEnterpriseKeyAdminsSid = 114, WinAuthenticationKeyTrustSid = 115, WinAuthenticationKeyPropertyMFASid = 116, WinAuthenticationKeyPropertyAttestationSid = 117, WinAuthenticationFreshKeyAuthSid = 118, WinBuiltinDeviceOwnersSid = 119, } WELL_KNOWN_SID_TYPE; #line 9632 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9642 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9694 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _ACL { BYTE AclRevision; BYTE Sbz1; WORD AclSize; WORD AceCount; WORD Sbz2; } ACL; typedef ACL *PACL; typedef struct _ACE_HEADER { BYTE AceType; BYTE AceFlags; WORD AceSize; } ACE_HEADER; typedef ACE_HEADER *PACE_HEADER; #line 9743 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9753 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9765 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9772 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 9785 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _ACCESS_ALLOWED_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } ACCESS_ALLOWED_ACE; typedef ACCESS_ALLOWED_ACE *PACCESS_ALLOWED_ACE; typedef struct _ACCESS_DENIED_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } ACCESS_DENIED_ACE; typedef ACCESS_DENIED_ACE *PACCESS_DENIED_ACE; typedef struct _SYSTEM_AUDIT_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } SYSTEM_AUDIT_ACE; typedef SYSTEM_AUDIT_ACE *PSYSTEM_AUDIT_ACE; typedef struct _SYSTEM_ALARM_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } SYSTEM_ALARM_ACE; typedef SYSTEM_ALARM_ACE *PSYSTEM_ALARM_ACE; typedef struct _SYSTEM_RESOURCE_ATTRIBUTE_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } SYSTEM_RESOURCE_ATTRIBUTE_ACE, *PSYSTEM_RESOURCE_ATTRIBUTE_ACE; typedef struct _SYSTEM_SCOPED_POLICY_ID_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } SYSTEM_SCOPED_POLICY_ID_ACE, *PSYSTEM_SCOPED_POLICY_ID_ACE; typedef struct _SYSTEM_MANDATORY_LABEL_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } SYSTEM_MANDATORY_LABEL_ACE, *PSYSTEM_MANDATORY_LABEL_ACE; typedef struct _SYSTEM_PROCESS_TRUST_LABEL_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } SYSTEM_PROCESS_TRUST_LABEL_ACE, *PSYSTEM_PROCESS_TRUST_LABEL_ACE; typedef struct _SYSTEM_ACCESS_FILTER_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } SYSTEM_ACCESS_FILTER_ACE, *PSYSTEM_ACCESS_FILTER_ACE; typedef struct _ACCESS_ALLOWED_OBJECT_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD Flags; GUID ObjectType; GUID InheritedObjectType; DWORD SidStart; } ACCESS_ALLOWED_OBJECT_ACE, *PACCESS_ALLOWED_OBJECT_ACE; typedef struct _ACCESS_DENIED_OBJECT_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD Flags; GUID ObjectType; GUID InheritedObjectType; DWORD SidStart; } ACCESS_DENIED_OBJECT_ACE, *PACCESS_DENIED_OBJECT_ACE; typedef struct _SYSTEM_AUDIT_OBJECT_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD Flags; GUID ObjectType; GUID InheritedObjectType; DWORD SidStart; } SYSTEM_AUDIT_OBJECT_ACE, *PSYSTEM_AUDIT_OBJECT_ACE; typedef struct _SYSTEM_ALARM_OBJECT_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD Flags; GUID ObjectType; GUID InheritedObjectType; DWORD SidStart; } SYSTEM_ALARM_OBJECT_ACE, *PSYSTEM_ALARM_OBJECT_ACE; typedef struct _ACCESS_ALLOWED_CALLBACK_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } ACCESS_ALLOWED_CALLBACK_ACE, *PACCESS_ALLOWED_CALLBACK_ACE; typedef struct _ACCESS_DENIED_CALLBACK_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } ACCESS_DENIED_CALLBACK_ACE, *PACCESS_DENIED_CALLBACK_ACE; typedef struct _SYSTEM_AUDIT_CALLBACK_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } SYSTEM_AUDIT_CALLBACK_ACE, *PSYSTEM_AUDIT_CALLBACK_ACE; typedef struct _SYSTEM_ALARM_CALLBACK_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD SidStart; } SYSTEM_ALARM_CALLBACK_ACE, *PSYSTEM_ALARM_CALLBACK_ACE; typedef struct _ACCESS_ALLOWED_CALLBACK_OBJECT_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD Flags; GUID ObjectType; GUID InheritedObjectType; DWORD SidStart; } ACCESS_ALLOWED_CALLBACK_OBJECT_ACE, *PACCESS_ALLOWED_CALLBACK_OBJECT_ACE; typedef struct _ACCESS_DENIED_CALLBACK_OBJECT_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD Flags; GUID ObjectType; GUID InheritedObjectType; DWORD SidStart; } ACCESS_DENIED_CALLBACK_OBJECT_ACE, *PACCESS_DENIED_CALLBACK_OBJECT_ACE; typedef struct _SYSTEM_AUDIT_CALLBACK_OBJECT_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD Flags; GUID ObjectType; GUID InheritedObjectType; DWORD SidStart; } SYSTEM_AUDIT_CALLBACK_OBJECT_ACE, *PSYSTEM_AUDIT_CALLBACK_OBJECT_ACE; typedef struct _SYSTEM_ALARM_CALLBACK_OBJECT_ACE { ACE_HEADER Header; ACCESS_MASK Mask; DWORD Flags; GUID ObjectType; GUID InheritedObjectType; DWORD SidStart; } SYSTEM_ALARM_CALLBACK_OBJECT_ACE, *PSYSTEM_ALARM_CALLBACK_OBJECT_ACE; typedef enum _ACL_INFORMATION_CLASS { AclRevisionInformation = 1, AclSizeInformation } ACL_INFORMATION_CLASS; typedef struct _ACL_REVISION_INFORMATION { DWORD AclRevision; } ACL_REVISION_INFORMATION; typedef ACL_REVISION_INFORMATION *PACL_REVISION_INFORMATION; typedef struct _ACL_SIZE_INFORMATION { DWORD AceCount; DWORD AclBytesInUse; DWORD AclBytesFree; } ACL_SIZE_INFORMATION; typedef ACL_SIZE_INFORMATION *PACL_SIZE_INFORMATION; typedef WORD SECURITY_DESCRIPTOR_CONTROL, *PSECURITY_DESCRIPTOR_CONTROL; #line 10121 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _SECURITY_DESCRIPTOR_RELATIVE { BYTE Revision; BYTE Sbz1; SECURITY_DESCRIPTOR_CONTROL Control; DWORD Owner; DWORD Group; DWORD Sacl; DWORD Dacl; } SECURITY_DESCRIPTOR_RELATIVE, *PISECURITY_DESCRIPTOR_RELATIVE; typedef struct _SECURITY_DESCRIPTOR { BYTE Revision; BYTE Sbz1; SECURITY_DESCRIPTOR_CONTROL Control; PSID Owner; PSID Group; PACL Sacl; PACL Dacl; } SECURITY_DESCRIPTOR, *PISECURITY_DESCRIPTOR; typedef struct _SECURITY_OBJECT_AI_PARAMS { DWORD Size; DWORD ConstraintMask; } SECURITY_OBJECT_AI_PARAMS, *PSECURITY_OBJECT_AI_PARAMS; typedef struct _OBJECT_TYPE_LIST { WORD Level; WORD Sbz; GUID *ObjectType; } OBJECT_TYPE_LIST, *POBJECT_TYPE_LIST; typedef enum _AUDIT_EVENT_TYPE { AuditEventObjectAccess, AuditEventDirectoryServiceAccess } AUDIT_EVENT_TYPE, *PAUDIT_EVENT_TYPE; typedef struct _PRIVILEGE_SET { DWORD PrivilegeCount; DWORD Control; LUID_AND_ATTRIBUTES Privilege[1]; } PRIVILEGE_SET, * PPRIVILEGE_SET; typedef enum _ACCESS_REASON_TYPE{ AccessReasonNone = 0x00000000, AccessReasonAllowedAce = 0x00010000, AccessReasonDeniedAce = 0x00020000, AccessReasonAllowedParentAce = 0x00030000, AccessReasonDeniedParentAce = 0x00040000, AccessReasonNotGrantedByCape = 0x00050000, AccessReasonNotGrantedByParentCape = 0x00060000, AccessReasonNotGrantedToAppContainer = 0x00070000, AccessReasonMissingPrivilege = 0x00100000, AccessReasonFromPrivilege = 0x00200000, AccessReasonIntegrityLevel = 0x00300000, AccessReasonOwnership = 0x00400000, AccessReasonNullDacl = 0x00500000, AccessReasonEmptyDacl = 0x00600000, AccessReasonNoSD = 0x00700000, AccessReasonNoGrant = 0x00800000, AccessReasonTrustLabel = 0x00900000, AccessReasonFilterAce = 0x00a00000 } ACCESS_REASON_TYPE; typedef DWORD ACCESS_REASON; typedef struct _ACCESS_REASONS{ ACCESS_REASON Data[32]; } ACCESS_REASONS, *PACCESS_REASONS; typedef struct _SE_SECURITY_DESCRIPTOR { DWORD Size; DWORD Flags; PSECURITY_DESCRIPTOR SecurityDescriptor; } SE_SECURITY_DESCRIPTOR, *PSE_SECURITY_DESCRIPTOR; typedef struct _SE_ACCESS_REQUEST { DWORD Size; PSE_SECURITY_DESCRIPTOR SeSecurityDescriptor; ACCESS_MASK DesiredAccess; ACCESS_MASK PreviouslyGrantedAccess; PSID PrincipalSelfSid; PGENERIC_MAPPING GenericMapping; DWORD ObjectTypeListCount; POBJECT_TYPE_LIST ObjectTypeList; } SE_ACCESS_REQUEST, *PSE_ACCESS_REQUEST; typedef struct _SE_ACCESS_REPLY { DWORD Size; DWORD ResultListCount; PACCESS_MASK GrantedAccess; PDWORD AccessStatus; PACCESS_REASONS AccessReason; PPRIVILEGE_SET* Privileges; } SE_ACCESS_REPLY, *PSE_ACCESS_REPLY; #line 10524 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef enum _SECURITY_IMPERSONATION_LEVEL { SecurityAnonymous, SecurityIdentification, SecurityImpersonation, SecurityDelegation } SECURITY_IMPERSONATION_LEVEL, * PSECURITY_IMPERSONATION_LEVEL; #line 10591 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 10601 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 10608 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef enum _TOKEN_TYPE { TokenPrimary = 1, TokenImpersonation } TOKEN_TYPE; typedef TOKEN_TYPE *PTOKEN_TYPE; typedef enum _TOKEN_ELEVATION_TYPE { TokenElevationTypeDefault = 1, TokenElevationTypeFull, TokenElevationTypeLimited, } TOKEN_ELEVATION_TYPE, *PTOKEN_ELEVATION_TYPE; typedef enum _TOKEN_INFORMATION_CLASS { TokenUser = 1, TokenGroups, TokenPrivileges, TokenOwner, TokenPrimaryGroup, TokenDefaultDacl, TokenSource, TokenType, TokenImpersonationLevel, TokenStatistics, TokenRestrictedSids, TokenSessionId, TokenGroupsAndPrivileges, TokenSessionReference, TokenSandBoxInert, TokenAuditPolicy, TokenOrigin, TokenElevationType, TokenLinkedToken, TokenElevation, TokenHasRestrictions, TokenAccessInformation, TokenVirtualizationAllowed, TokenVirtualizationEnabled, TokenIntegrityLevel, TokenUIAccess, TokenMandatoryPolicy, TokenLogonSid, TokenIsAppContainer, TokenCapabilities, TokenAppContainerSid, TokenAppContainerNumber, TokenUserClaimAttributes, TokenDeviceClaimAttributes, TokenRestrictedUserClaimAttributes, TokenRestrictedDeviceClaimAttributes, TokenDeviceGroups, TokenRestrictedDeviceGroups, TokenSecurityAttributes, TokenIsRestricted, TokenProcessTrustLevel, TokenPrivateNameSpace, TokenSingletonAttributes, TokenBnoIsolation, TokenChildProcessFlags, MaxTokenInfoClass } TOKEN_INFORMATION_CLASS, *PTOKEN_INFORMATION_CLASS; typedef struct _TOKEN_USER { SID_AND_ATTRIBUTES User; } TOKEN_USER, *PTOKEN_USER; typedef struct _SE_TOKEN_USER { union { TOKEN_USER TokenUser; SID_AND_ATTRIBUTES User; } ; union { SID Sid; BYTE Buffer[(sizeof(SID) - sizeof(DWORD) + ((15) * sizeof(DWORD)))]; } ; } SE_TOKEN_USER , PSE_TOKEN_USER; typedef struct _TOKEN_GROUPS { DWORD GroupCount; SID_AND_ATTRIBUTES Groups[1]; } TOKEN_GROUPS, *PTOKEN_GROUPS; typedef struct _TOKEN_PRIVILEGES { DWORD PrivilegeCount; LUID_AND_ATTRIBUTES Privileges[1]; } TOKEN_PRIVILEGES, *PTOKEN_PRIVILEGES; typedef struct _TOKEN_OWNER { PSID Owner; } TOKEN_OWNER, *PTOKEN_OWNER; typedef struct _TOKEN_PRIMARY_GROUP { PSID PrimaryGroup; } TOKEN_PRIMARY_GROUP, *PTOKEN_PRIMARY_GROUP; typedef struct _TOKEN_DEFAULT_DACL { PACL DefaultDacl; } TOKEN_DEFAULT_DACL, *PTOKEN_DEFAULT_DACL; typedef struct _TOKEN_USER_CLAIMS { PCLAIMS_BLOB UserClaims; } TOKEN_USER_CLAIMS, *PTOKEN_USER_CLAIMS; typedef struct _TOKEN_DEVICE_CLAIMS { PCLAIMS_BLOB DeviceClaims; } TOKEN_DEVICE_CLAIMS, *PTOKEN_DEVICE_CLAIMS; typedef struct _TOKEN_GROUPS_AND_PRIVILEGES { DWORD SidCount; DWORD SidLength; PSID_AND_ATTRIBUTES Sids; DWORD RestrictedSidCount; DWORD RestrictedSidLength; PSID_AND_ATTRIBUTES RestrictedSids; DWORD PrivilegeCount; DWORD PrivilegeLength; PLUID_AND_ATTRIBUTES Privileges; LUID AuthenticationId; } TOKEN_GROUPS_AND_PRIVILEGES, *PTOKEN_GROUPS_AND_PRIVILEGES; typedef struct _TOKEN_LINKED_TOKEN { HANDLE LinkedToken; } TOKEN_LINKED_TOKEN, *PTOKEN_LINKED_TOKEN; typedef struct _TOKEN_ELEVATION { DWORD TokenIsElevated; } TOKEN_ELEVATION, *PTOKEN_ELEVATION; typedef struct _TOKEN_MANDATORY_LABEL { SID_AND_ATTRIBUTES Label; } TOKEN_MANDATORY_LABEL, *PTOKEN_MANDATORY_LABEL; typedef struct _TOKEN_MANDATORY_POLICY { DWORD Policy; } TOKEN_MANDATORY_POLICY, *PTOKEN_MANDATORY_POLICY; typedef PVOID PSECURITY_ATTRIBUTES_OPAQUE; typedef struct _TOKEN_ACCESS_INFORMATION { PSID_AND_ATTRIBUTES_HASH SidHash; PSID_AND_ATTRIBUTES_HASH RestrictedSidHash; PTOKEN_PRIVILEGES Privileges; LUID AuthenticationId; TOKEN_TYPE TokenType; SECURITY_IMPERSONATION_LEVEL ImpersonationLevel; TOKEN_MANDATORY_POLICY MandatoryPolicy; DWORD Flags; DWORD AppContainerNumber; PSID PackageSid; PSID_AND_ATTRIBUTES_HASH CapabilitiesHash; PSID TrustLevelSid; PSECURITY_ATTRIBUTES_OPAQUE SecurityAttributes; } TOKEN_ACCESS_INFORMATION, *PTOKEN_ACCESS_INFORMATION; typedef struct _TOKEN_AUDIT_POLICY { BYTE PerUserPolicy[(((59)) >> 1) + 1]; } TOKEN_AUDIT_POLICY, *PTOKEN_AUDIT_POLICY; typedef struct _TOKEN_SOURCE { CHAR SourceName[8]; LUID SourceIdentifier; } TOKEN_SOURCE, *PTOKEN_SOURCE; typedef struct _TOKEN_STATISTICS { LUID TokenId; LUID AuthenticationId; LARGE_INTEGER ExpirationTime; TOKEN_TYPE TokenType; SECURITY_IMPERSONATION_LEVEL ImpersonationLevel; DWORD DynamicCharged; DWORD DynamicAvailable; DWORD GroupCount; DWORD PrivilegeCount; LUID ModifiedId; } TOKEN_STATISTICS, *PTOKEN_STATISTICS; typedef struct _TOKEN_CONTROL { LUID TokenId; LUID AuthenticationId; LUID ModifiedId; TOKEN_SOURCE TokenSource; } TOKEN_CONTROL, *PTOKEN_CONTROL; typedef struct _TOKEN_ORIGIN { LUID OriginatingLogonSession ; } TOKEN_ORIGIN, * PTOKEN_ORIGIN ; typedef enum _MANDATORY_LEVEL { MandatoryLevelUntrusted = 0, MandatoryLevelLow, MandatoryLevelMedium, MandatoryLevelHigh, MandatoryLevelSystem, MandatoryLevelSecureProcess, MandatoryLevelCount } MANDATORY_LEVEL, *PMANDATORY_LEVEL; typedef struct _TOKEN_APPCONTAINER_INFORMATION { PSID TokenAppContainer; } TOKEN_APPCONTAINER_INFORMATION, *PTOKEN_APPCONTAINER_INFORMATION; typedef struct _TOKEN_SID_INFORMATION { PSID Sid; } TOKEN_SID_INFORMATION, *PTOKEN_SID_INFORMATION; typedef struct _TOKEN_BNO_ISOLATION_INFORMATION { PWSTR IsolationPrefix; BOOLEAN IsolationEnabled; } TOKEN_BNO_ISOLATION_INFORMATION, *PTOKEN_BNO_ISOLATION_INFORMATION; typedef struct _CLAIM_SECURITY_ATTRIBUTE_FQBN_VALUE { DWORD64 Version; PWSTR Name; } CLAIM_SECURITY_ATTRIBUTE_FQBN_VALUE, *PCLAIM_SECURITY_ATTRIBUTE_FQBN_VALUE; typedef struct _CLAIM_SECURITY_ATTRIBUTE_OCTET_STRING_VALUE { PVOID pValue; DWORD ValueLength; } CLAIM_SECURITY_ATTRIBUTE_OCTET_STRING_VALUE, *PCLAIM_SECURITY_ATTRIBUTE_OCTET_STRING_VALUE; #line 11008 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _CLAIM_SECURITY_ATTRIBUTE_V1 { PWSTR Name; WORD ValueType; WORD Reserved; DWORD Flags; DWORD ValueCount; union { PLONG64 pInt64; PDWORD64 pUint64; PWSTR *ppString; PCLAIM_SECURITY_ATTRIBUTE_FQBN_VALUE pFqbn; PCLAIM_SECURITY_ATTRIBUTE_OCTET_STRING_VALUE pOctetString; } Values; } CLAIM_SECURITY_ATTRIBUTE_V1, *PCLAIM_SECURITY_ATTRIBUTE_V1; typedef struct _CLAIM_SECURITY_ATTRIBUTE_RELATIVE_V1 { DWORD Name; WORD ValueType; WORD Reserved; DWORD Flags; DWORD ValueCount; union { DWORD pInt64[1]; DWORD pUint64[1]; DWORD ppString[1]; DWORD pFqbn[1]; DWORD pOctetString[1]; } Values; } CLAIM_SECURITY_ATTRIBUTE_RELATIVE_V1, *PCLAIM_SECURITY_ATTRIBUTE_RELATIVE_V1; typedef struct _CLAIM_SECURITY_ATTRIBUTES_INFORMATION { WORD Version; WORD Reserved; DWORD AttributeCount; union { PCLAIM_SECURITY_ATTRIBUTE_V1 pAttributeV1; } Attribute; } CLAIM_SECURITY_ATTRIBUTES_INFORMATION, *PCLAIM_SECURITY_ATTRIBUTES_INFORMATION; typedef BOOLEAN SECURITY_CONTEXT_TRACKING_MODE, * PSECURITY_CONTEXT_TRACKING_MODE; typedef struct _SECURITY_QUALITY_OF_SERVICE { DWORD Length; SECURITY_IMPERSONATION_LEVEL ImpersonationLevel; SECURITY_CONTEXT_TRACKING_MODE ContextTrackingMode; BOOLEAN EffectiveOnly; } SECURITY_QUALITY_OF_SERVICE, * PSECURITY_QUALITY_OF_SERVICE; typedef struct _SE_IMPERSONATION_STATE { PACCESS_TOKEN Token; BOOLEAN CopyOnOpen; BOOLEAN EffectiveOnly; SECURITY_IMPERSONATION_LEVEL Level; } SE_IMPERSONATION_STATE, *PSE_IMPERSONATION_STATE; typedef DWORD SECURITY_INFORMATION, *PSECURITY_INFORMATION; #line 11212 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef BYTE SE_SIGNING_LEVEL, *PSE_SIGNING_LEVEL; #line 11242 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef enum _SE_IMAGE_SIGNATURE_TYPE { SeImageSignatureNone = 0, SeImageSignatureEmbedded, SeImageSignatureCache, SeImageSignatureCatalogCached, SeImageSignatureCatalogNotCached, SeImageSignatureCatalogHint, SeImageSignaturePackageCatalog, } SE_IMAGE_SIGNATURE_TYPE, *PSE_IMAGE_SIGNATURE_TYPE; typedef enum _SE_LEARNING_MODE_DATA_TYPE { SeLearningModeInvalidType = 0, SeLearningModeSettings, SeLearningModeMax } SE_LEARNING_MODE_DATA_TYPE; typedef struct _SECURITY_CAPABILITIES { PSID AppContainerSid; PSID_AND_ATTRIBUTES Capabilities; DWORD CapabilityCount; DWORD Reserved; } SECURITY_CAPABILITIES, *PSECURITY_CAPABILITIES, *LPSECURITY_CAPABILITIES; #line 11305 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 11315 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 11334 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _JOB_SET_ARRAY { HANDLE JobHandle; DWORD MemberLevel; DWORD Flags; } JOB_SET_ARRAY, *PJOB_SET_ARRAY; typedef struct _EXCEPTION_REGISTRATION_RECORD { struct _EXCEPTION_REGISTRATION_RECORD *Next; PEXCEPTION_ROUTINE Handler; } EXCEPTION_REGISTRATION_RECORD; typedef EXCEPTION_REGISTRATION_RECORD *PEXCEPTION_REGISTRATION_RECORD; typedef struct _NT_TIB { struct _EXCEPTION_REGISTRATION_RECORD *ExceptionList; PVOID StackBase; PVOID StackLimit; PVOID SubSystemTib; union { PVOID FiberData; DWORD Version; }; PVOID ArbitraryUserPointer; struct _NT_TIB *Self; } NT_TIB; typedef NT_TIB *PNT_TIB; typedef struct _NT_TIB32 { DWORD ExceptionList; DWORD StackBase; DWORD StackLimit; DWORD SubSystemTib; union { DWORD FiberData; DWORD Version; }; DWORD ArbitraryUserPointer; DWORD Self; } NT_TIB32, *PNT_TIB32; typedef struct _NT_TIB64 { DWORD64 ExceptionList; DWORD64 StackBase; DWORD64 StackLimit; DWORD64 SubSystemTib; union { DWORD64 FiberData; DWORD Version; }; DWORD64 ArbitraryUserPointer; DWORD64 Self; } NT_TIB64, *PNT_TIB64; typedef struct _UMS_CREATE_THREAD_ATTRIBUTES { DWORD UmsVersion; PVOID UmsContext; PVOID UmsCompletionList; } UMS_CREATE_THREAD_ATTRIBUTES, *PUMS_CREATE_THREAD_ATTRIBUTES; typedef struct _WOW64_ARCHITECTURE_INFORMATION { DWORD Machine : 16; DWORD KernelMode : 1; DWORD UserMode : 1; DWORD Native : 1; DWORD Process : 1; DWORD ReservedZero0 : 12; } WOW64_ARCHITECTURE_INFORMATION; #line 11448 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _QUOTA_LIMITS { SIZE_T PagedPoolLimit; SIZE_T NonPagedPoolLimit; SIZE_T MinimumWorkingSetSize; SIZE_T MaximumWorkingSetSize; SIZE_T PagefileLimit; LARGE_INTEGER TimeLimit; } QUOTA_LIMITS, *PQUOTA_LIMITS; typedef union _RATE_QUOTA_LIMIT { DWORD RateData; struct { DWORD RatePercent : 7; DWORD Reserved0 : 25; } ; } RATE_QUOTA_LIMIT, *PRATE_QUOTA_LIMIT; typedef struct _QUOTA_LIMITS_EX { SIZE_T PagedPoolLimit; SIZE_T NonPagedPoolLimit; SIZE_T MinimumWorkingSetSize; SIZE_T MaximumWorkingSetSize; SIZE_T PagefileLimit; LARGE_INTEGER TimeLimit; SIZE_T WorkingSetLimit; SIZE_T Reserved2; SIZE_T Reserved3; SIZE_T Reserved4; DWORD Flags; RATE_QUOTA_LIMIT CpuRateLimit; } QUOTA_LIMITS_EX, *PQUOTA_LIMITS_EX; typedef struct _IO_COUNTERS { ULONGLONG ReadOperationCount; ULONGLONG WriteOperationCount; ULONGLONG OtherOperationCount; ULONGLONG ReadTransferCount; ULONGLONG WriteTransferCount; ULONGLONG OtherTransferCount; } IO_COUNTERS; typedef IO_COUNTERS *PIO_COUNTERS; typedef enum _HARDWARE_COUNTER_TYPE { PMCCounter, MaxHardwareCounterType } HARDWARE_COUNTER_TYPE, *PHARDWARE_COUNTER_TYPE; typedef enum _PROCESS_MITIGATION_POLICY { ProcessDEPPolicy, ProcessASLRPolicy, ProcessDynamicCodePolicy, ProcessStrictHandleCheckPolicy, ProcessSystemCallDisablePolicy, ProcessMitigationOptionsMask, ProcessExtensionPointDisablePolicy, ProcessControlFlowGuardPolicy, ProcessSignaturePolicy, ProcessFontDisablePolicy, ProcessImageLoadPolicy, ProcessSystemCallFilterPolicy, ProcessPayloadRestrictionPolicy, ProcessChildProcessPolicy, MaxProcessMitigationPolicy } PROCESS_MITIGATION_POLICY, *PPROCESS_MITIGATION_POLICY; typedef struct _PROCESS_MITIGATION_ASLR_POLICY { union { DWORD Flags; struct { DWORD EnableBottomUpRandomization : 1; DWORD EnableForceRelocateImages : 1; DWORD EnableHighEntropy : 1; DWORD DisallowStrippedImages : 1; DWORD ReservedFlags : 28; } ; } ; } PROCESS_MITIGATION_ASLR_POLICY, *PPROCESS_MITIGATION_ASLR_POLICY; typedef struct _PROCESS_MITIGATION_DEP_POLICY { union { DWORD Flags; struct { DWORD Enable : 1; DWORD DisableAtlThunkEmulation : 1; DWORD ReservedFlags : 30; } ; } ; BOOLEAN Permanent; } PROCESS_MITIGATION_DEP_POLICY, *PPROCESS_MITIGATION_DEP_POLICY; typedef struct _PROCESS_MITIGATION_STRICT_HANDLE_CHECK_POLICY { union { DWORD Flags; struct { DWORD RaiseExceptionOnInvalidHandleReference : 1; DWORD HandleExceptionsPermanentlyEnabled : 1; DWORD ReservedFlags : 30; } ; } ; } PROCESS_MITIGATION_STRICT_HANDLE_CHECK_POLICY, *PPROCESS_MITIGATION_STRICT_HANDLE_CHECK_POLICY; typedef struct _PROCESS_MITIGATION_SYSTEM_CALL_DISABLE_POLICY { union { DWORD Flags; struct { DWORD DisallowWin32kSystemCalls : 1; DWORD AuditDisallowWin32kSystemCalls : 1; DWORD ReservedFlags : 30; } ; } ; } PROCESS_MITIGATION_SYSTEM_CALL_DISABLE_POLICY, *PPROCESS_MITIGATION_SYSTEM_CALL_DISABLE_POLICY; typedef struct _PROCESS_MITIGATION_EXTENSION_POINT_DISABLE_POLICY { union { DWORD Flags; struct { DWORD DisableExtensionPoints : 1; DWORD ReservedFlags : 31; } ; } ; } PROCESS_MITIGATION_EXTENSION_POINT_DISABLE_POLICY, *PPROCESS_MITIGATION_EXTENSION_POINT_DISABLE_POLICY; typedef struct _PROCESS_MITIGATION_DYNAMIC_CODE_POLICY { union { DWORD Flags; struct { DWORD ProhibitDynamicCode : 1; DWORD AllowThreadOptOut : 1; DWORD AllowRemoteDowngrade : 1; DWORD AuditProhibitDynamicCode : 1; DWORD ReservedFlags : 28; } ; } ; } PROCESS_MITIGATION_DYNAMIC_CODE_POLICY, *PPROCESS_MITIGATION_DYNAMIC_CODE_POLICY; typedef struct _PROCESS_MITIGATION_CONTROL_FLOW_GUARD_POLICY { union { DWORD Flags; struct { DWORD EnableControlFlowGuard : 1; DWORD EnableExportSuppression : 1; DWORD StrictMode : 1; DWORD ReservedFlags : 29; } ; } ; } PROCESS_MITIGATION_CONTROL_FLOW_GUARD_POLICY, *PPROCESS_MITIGATION_CONTROL_FLOW_GUARD_POLICY; typedef struct _PROCESS_MITIGATION_BINARY_SIGNATURE_POLICY { union { DWORD Flags; struct { DWORD MicrosoftSignedOnly : 1; DWORD StoreSignedOnly : 1; DWORD MitigationOptIn : 1; DWORD AuditMicrosoftSignedOnly : 1; DWORD AuditStoreSignedOnly : 1; DWORD ReservedFlags : 27; } ; } ; } PROCESS_MITIGATION_BINARY_SIGNATURE_POLICY, *PPROCESS_MITIGATION_BINARY_SIGNATURE_POLICY; typedef struct _PROCESS_MITIGATION_FONT_DISABLE_POLICY { union { DWORD Flags; struct { DWORD DisableNonSystemFonts : 1; DWORD AuditNonSystemFontLoading : 1; DWORD ReservedFlags : 30; } ; } ; } PROCESS_MITIGATION_FONT_DISABLE_POLICY, *PPROCESS_MITIGATION_FONT_DISABLE_POLICY; typedef struct _PROCESS_MITIGATION_IMAGE_LOAD_POLICY { union { DWORD Flags; struct { DWORD NoRemoteImages : 1; DWORD NoLowMandatoryLabelImages : 1; DWORD PreferSystem32Images : 1; DWORD AuditNoRemoteImages : 1; DWORD AuditNoLowMandatoryLabelImages : 1; DWORD ReservedFlags : 27; } ; } ; } PROCESS_MITIGATION_IMAGE_LOAD_POLICY, *PPROCESS_MITIGATION_IMAGE_LOAD_POLICY; typedef struct _PROCESS_MITIGATION_SYSTEM_CALL_FILTER_POLICY { union { DWORD Flags; struct { DWORD FilterId: 4; DWORD ReservedFlags : 28; } ; } ; } PROCESS_MITIGATION_SYSTEM_CALL_FILTER_POLICY, *PPROCESS_MITIGATION_SYSTEM_CALL_FILTER_POLICY; typedef struct _PROCESS_MITIGATION_PAYLOAD_RESTRICTION_POLICY { union { DWORD Flags; struct { DWORD EnableExportAddressFilter : 1; DWORD AuditExportAddressFilter : 1; DWORD EnableExportAddressFilterPlus : 1; DWORD AuditExportAddressFilterPlus : 1; DWORD EnableImportAddressFilter : 1; DWORD AuditImportAddressFilter : 1; DWORD EnableRopStackPivot : 1; DWORD AuditRopStackPivot : 1; DWORD EnableRopCallerCheck : 1; DWORD AuditRopCallerCheck : 1; DWORD EnableRopSimExec : 1; DWORD AuditRopSimExec : 1; DWORD ReservedFlags : 20; } ; } ; } PROCESS_MITIGATION_PAYLOAD_RESTRICTION_POLICY, *PPROCESS_MITIGATION_PAYLOAD_RESTRICTION_POLICY; typedef struct _PROCESS_MITIGATION_CHILD_PROCESS_POLICY { union { DWORD Flags; struct { DWORD NoChildProcessCreation : 1; DWORD AuditNoChildProcessCreation : 1; DWORD AllowSecureProcessCreation : 1; DWORD ReservedFlags : 29; } ; } ; } PROCESS_MITIGATION_CHILD_PROCESS_POLICY, *PPROCESS_MITIGATION_CHILD_PROCESS_POLICY; typedef struct _JOBOBJECT_BASIC_ACCOUNTING_INFORMATION { LARGE_INTEGER TotalUserTime; LARGE_INTEGER TotalKernelTime; LARGE_INTEGER ThisPeriodTotalUserTime; LARGE_INTEGER ThisPeriodTotalKernelTime; DWORD TotalPageFaultCount; DWORD TotalProcesses; DWORD ActiveProcesses; DWORD TotalTerminatedProcesses; } JOBOBJECT_BASIC_ACCOUNTING_INFORMATION, *PJOBOBJECT_BASIC_ACCOUNTING_INFORMATION; typedef struct _JOBOBJECT_BASIC_LIMIT_INFORMATION { LARGE_INTEGER PerProcessUserTimeLimit; LARGE_INTEGER PerJobUserTimeLimit; DWORD LimitFlags; SIZE_T MinimumWorkingSetSize; SIZE_T MaximumWorkingSetSize; DWORD ActiveProcessLimit; ULONG_PTR Affinity; DWORD PriorityClass; DWORD SchedulingClass; } JOBOBJECT_BASIC_LIMIT_INFORMATION, *PJOBOBJECT_BASIC_LIMIT_INFORMATION; typedef struct _JOBOBJECT_EXTENDED_LIMIT_INFORMATION { JOBOBJECT_BASIC_LIMIT_INFORMATION BasicLimitInformation; IO_COUNTERS IoInfo; SIZE_T ProcessMemoryLimit; SIZE_T JobMemoryLimit; SIZE_T PeakProcessMemoryUsed; SIZE_T PeakJobMemoryUsed; } JOBOBJECT_EXTENDED_LIMIT_INFORMATION, *PJOBOBJECT_EXTENDED_LIMIT_INFORMATION; typedef struct _JOBOBJECT_BASIC_PROCESS_ID_LIST { DWORD NumberOfAssignedProcesses; DWORD NumberOfProcessIdsInList; ULONG_PTR ProcessIdList[1]; } JOBOBJECT_BASIC_PROCESS_ID_LIST, *PJOBOBJECT_BASIC_PROCESS_ID_LIST; typedef struct _JOBOBJECT_BASIC_UI_RESTRICTIONS { DWORD UIRestrictionsClass; } JOBOBJECT_BASIC_UI_RESTRICTIONS, *PJOBOBJECT_BASIC_UI_RESTRICTIONS; typedef struct _JOBOBJECT_SECURITY_LIMIT_INFORMATION { DWORD SecurityLimitFlags ; HANDLE JobToken ; PTOKEN_GROUPS SidsToDisable ; PTOKEN_PRIVILEGES PrivilegesToDelete ; PTOKEN_GROUPS RestrictedSids ; } JOBOBJECT_SECURITY_LIMIT_INFORMATION, *PJOBOBJECT_SECURITY_LIMIT_INFORMATION ; typedef struct _JOBOBJECT_END_OF_JOB_TIME_INFORMATION { DWORD EndOfJobTimeAction; } JOBOBJECT_END_OF_JOB_TIME_INFORMATION, *PJOBOBJECT_END_OF_JOB_TIME_INFORMATION; typedef struct _JOBOBJECT_ASSOCIATE_COMPLETION_PORT { PVOID CompletionKey; HANDLE CompletionPort; } JOBOBJECT_ASSOCIATE_COMPLETION_PORT, *PJOBOBJECT_ASSOCIATE_COMPLETION_PORT; typedef struct _JOBOBJECT_BASIC_AND_IO_ACCOUNTING_INFORMATION { JOBOBJECT_BASIC_ACCOUNTING_INFORMATION BasicInfo; IO_COUNTERS IoInfo; } JOBOBJECT_BASIC_AND_IO_ACCOUNTING_INFORMATION, *PJOBOBJECT_BASIC_AND_IO_ACCOUNTING_INFORMATION; typedef struct _JOBOBJECT_JOBSET_INFORMATION { DWORD MemberLevel; } JOBOBJECT_JOBSET_INFORMATION, *PJOBOBJECT_JOBSET_INFORMATION; typedef enum _JOBOBJECT_RATE_CONTROL_TOLERANCE { ToleranceLow = 1, ToleranceMedium, ToleranceHigh } JOBOBJECT_RATE_CONTROL_TOLERANCE, *PJOBOBJECT_RATE_CONTROL_TOLERANCE; typedef enum _JOBOBJECT_RATE_CONTROL_TOLERANCE_INTERVAL { ToleranceIntervalShort = 1, ToleranceIntervalMedium, ToleranceIntervalLong } JOBOBJECT_RATE_CONTROL_TOLERANCE_INTERVAL, *PJOBOBJECT_RATE_CONTROL_TOLERANCE_INTERVAL; typedef struct _JOBOBJECT_NOTIFICATION_LIMIT_INFORMATION { DWORD64 IoReadBytesLimit; DWORD64 IoWriteBytesLimit; LARGE_INTEGER PerJobUserTimeLimit; DWORD64 JobMemoryLimit; JOBOBJECT_RATE_CONTROL_TOLERANCE RateControlTolerance; JOBOBJECT_RATE_CONTROL_TOLERANCE_INTERVAL RateControlToleranceInterval; DWORD LimitFlags; } JOBOBJECT_NOTIFICATION_LIMIT_INFORMATION, *PJOBOBJECT_NOTIFICATION_LIMIT_INFORMATION; typedef struct JOBOBJECT_NOTIFICATION_LIMIT_INFORMATION_2 { DWORD64 IoReadBytesLimit; DWORD64 IoWriteBytesLimit; LARGE_INTEGER PerJobUserTimeLimit; union { DWORD64 JobHighMemoryLimit; DWORD64 JobMemoryLimit; } ; union { JOBOBJECT_RATE_CONTROL_TOLERANCE RateControlTolerance; JOBOBJECT_RATE_CONTROL_TOLERANCE CpuRateControlTolerance; } ; union { JOBOBJECT_RATE_CONTROL_TOLERANCE_INTERVAL RateControlToleranceInterval; JOBOBJECT_RATE_CONTROL_TOLERANCE_INTERVAL CpuRateControlToleranceInterval; } ; DWORD LimitFlags; JOBOBJECT_RATE_CONTROL_TOLERANCE IoRateControlTolerance; DWORD64 JobLowMemoryLimit; JOBOBJECT_RATE_CONTROL_TOLERANCE_INTERVAL IoRateControlToleranceInterval; JOBOBJECT_RATE_CONTROL_TOLERANCE NetRateControlTolerance; JOBOBJECT_RATE_CONTROL_TOLERANCE_INTERVAL NetRateControlToleranceInterval; } JOBOBJECT_NOTIFICATION_LIMIT_INFORMATION_2; typedef struct _JOBOBJECT_LIMIT_VIOLATION_INFORMATION { DWORD LimitFlags; DWORD ViolationLimitFlags; DWORD64 IoReadBytes; DWORD64 IoReadBytesLimit; DWORD64 IoWriteBytes; DWORD64 IoWriteBytesLimit; LARGE_INTEGER PerJobUserTime; LARGE_INTEGER PerJobUserTimeLimit; DWORD64 JobMemory; DWORD64 JobMemoryLimit; JOBOBJECT_RATE_CONTROL_TOLERANCE RateControlTolerance; JOBOBJECT_RATE_CONTROL_TOLERANCE RateControlToleranceLimit; } JOBOBJECT_LIMIT_VIOLATION_INFORMATION, *PJOBOBJECT_LIMIT_VIOLATION_INFORMATION; typedef struct JOBOBJECT_LIMIT_VIOLATION_INFORMATION_2 { DWORD LimitFlags; DWORD ViolationLimitFlags; DWORD64 IoReadBytes; DWORD64 IoReadBytesLimit; DWORD64 IoWriteBytes; DWORD64 IoWriteBytesLimit; LARGE_INTEGER PerJobUserTime; LARGE_INTEGER PerJobUserTimeLimit; DWORD64 JobMemory; union { DWORD64 JobHighMemoryLimit; DWORD64 JobMemoryLimit; } ; union { JOBOBJECT_RATE_CONTROL_TOLERANCE RateControlTolerance; JOBOBJECT_RATE_CONTROL_TOLERANCE CpuRateControlTolerance; } ; union { JOBOBJECT_RATE_CONTROL_TOLERANCE RateControlToleranceLimit; JOBOBJECT_RATE_CONTROL_TOLERANCE CpuRateControlToleranceLimit; } ; DWORD64 JobLowMemoryLimit; JOBOBJECT_RATE_CONTROL_TOLERANCE IoRateControlTolerance; JOBOBJECT_RATE_CONTROL_TOLERANCE IoRateControlToleranceLimit; JOBOBJECT_RATE_CONTROL_TOLERANCE NetRateControlTolerance; JOBOBJECT_RATE_CONTROL_TOLERANCE NetRateControlToleranceLimit; } JOBOBJECT_LIMIT_VIOLATION_INFORMATION_2; typedef struct _JOBOBJECT_CPU_RATE_CONTROL_INFORMATION { DWORD ControlFlags; union { DWORD CpuRate; DWORD Weight; struct { WORD MinRate; WORD MaxRate; } ; } ; } JOBOBJECT_CPU_RATE_CONTROL_INFORMATION, *PJOBOBJECT_CPU_RATE_CONTROL_INFORMATION; typedef enum JOB_OBJECT_NET_RATE_CONTROL_FLAGS { JOB_OBJECT_NET_RATE_CONTROL_ENABLE = 0x1, JOB_OBJECT_NET_RATE_CONTROL_MAX_BANDWIDTH = 0x2, JOB_OBJECT_NET_RATE_CONTROL_DSCP_TAG = 0x4, JOB_OBJECT_NET_RATE_CONTROL_VALID_FLAGS = 0x7 } JOB_OBJECT_NET_RATE_CONTROL_FLAGS; typedef char __C_ASSERT__[(JOB_OBJECT_NET_RATE_CONTROL_VALID_FLAGS == (JOB_OBJECT_NET_RATE_CONTROL_ENABLE + JOB_OBJECT_NET_RATE_CONTROL_MAX_BANDWIDTH + JOB_OBJECT_NET_RATE_CONTROL_DSCP_TAG))?1:-1]; typedef struct JOBOBJECT_NET_RATE_CONTROL_INFORMATION { DWORD64 MaxBandwidth; JOB_OBJECT_NET_RATE_CONTROL_FLAGS ControlFlags; BYTE DscpTag; } JOBOBJECT_NET_RATE_CONTROL_INFORMATION; typedef enum JOB_OBJECT_IO_RATE_CONTROL_FLAGS { JOB_OBJECT_IO_RATE_CONTROL_ENABLE = 0x1, JOB_OBJECT_IO_RATE_CONTROL_STANDALONE_VOLUME = 0x2, JOB_OBJECT_IO_RATE_CONTROL_FORCE_UNIT_ACCESS_ALL = 0x4, JOB_OBJECT_IO_RATE_CONTROL_FORCE_UNIT_ACCESS_ON_SOFT_CAP = 0x8, JOB_OBJECT_IO_RATE_CONTROL_VALID_FLAGS = JOB_OBJECT_IO_RATE_CONTROL_ENABLE | JOB_OBJECT_IO_RATE_CONTROL_STANDALONE_VOLUME | JOB_OBJECT_IO_RATE_CONTROL_FORCE_UNIT_ACCESS_ALL | JOB_OBJECT_IO_RATE_CONTROL_FORCE_UNIT_ACCESS_ON_SOFT_CAP } JOB_OBJECT_IO_RATE_CONTROL_FLAGS; typedef struct JOBOBJECT_IO_RATE_CONTROL_INFORMATION_NATIVE { LONG64 MaxIops; LONG64 MaxBandwidth; LONG64 ReservationIops; PWSTR VolumeName; DWORD BaseIoSize; JOB_OBJECT_IO_RATE_CONTROL_FLAGS ControlFlags; WORD VolumeNameLength; } JOBOBJECT_IO_RATE_CONTROL_INFORMATION_NATIVE; typedef JOBOBJECT_IO_RATE_CONTROL_INFORMATION_NATIVE JOBOBJECT_IO_RATE_CONTROL_INFORMATION_NATIVE_V1; typedef struct JOBOBJECT_IO_RATE_CONTROL_INFORMATION_NATIVE_V2 { LONG64 MaxIops; LONG64 MaxBandwidth; LONG64 ReservationIops; PWSTR VolumeName; DWORD BaseIoSize; JOB_OBJECT_IO_RATE_CONTROL_FLAGS ControlFlags; WORD VolumeNameLength; LONG64 CriticalReservationIops; LONG64 ReservationBandwidth; LONG64 CriticalReservationBandwidth; LONG64 MaxTimePercent; LONG64 ReservationTimePercent; LONG64 CriticalReservationTimePercent; } JOBOBJECT_IO_RATE_CONTROL_INFORMATION_NATIVE_V2; typedef struct JOBOBJECT_IO_RATE_CONTROL_INFORMATION_NATIVE_V3 { LONG64 MaxIops; LONG64 MaxBandwidth; LONG64 ReservationIops; PWSTR VolumeName; DWORD BaseIoSize; JOB_OBJECT_IO_RATE_CONTROL_FLAGS ControlFlags; WORD VolumeNameLength; LONG64 CriticalReservationIops; LONG64 ReservationBandwidth; LONG64 CriticalReservationBandwidth; LONG64 MaxTimePercent; LONG64 ReservationTimePercent; LONG64 CriticalReservationTimePercent; LONG64 SoftMaxIops; LONG64 SoftMaxBandwidth; LONG64 SoftMaxTimePercent; LONG64 LimitExcessNotifyIops; LONG64 LimitExcessNotifyBandwidth; LONG64 LimitExcessNotifyTimePercent; } JOBOBJECT_IO_RATE_CONTROL_INFORMATION_NATIVE_V3; typedef enum JOBOBJECT_IO_ATTRIBUTION_CONTROL_FLAGS { JOBOBJECT_IO_ATTRIBUTION_CONTROL_ENABLE = 0x1, JOBOBJECT_IO_ATTRIBUTION_CONTROL_DISABLE = 0x2, JOBOBJECT_IO_ATTRIBUTION_CONTROL_VALID_FLAGS = 0x3 } JOBOBJECT_IO_ATTRIBUTION_CONTROL_FLAGS; typedef struct _JOBOBJECT_IO_ATTRIBUTION_STATS { ULONG_PTR IoCount; ULONGLONG TotalNonOverlappedQueueTime; ULONGLONG TotalNonOverlappedServiceTime; ULONGLONG TotalSize; } JOBOBJECT_IO_ATTRIBUTION_STATS, *PJOBOBJECT_IO_ATTRIBUTION_STATS; typedef struct _JOBOBJECT_IO_ATTRIBUTION_INFORMATION { DWORD ControlFlags; JOBOBJECT_IO_ATTRIBUTION_STATS ReadStats; JOBOBJECT_IO_ATTRIBUTION_STATS WriteStats; } JOBOBJECT_IO_ATTRIBUTION_INFORMATION, *PJOBOBJECT_IO_ATTRIBUTION_INFORMATION; #line 12035 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12058 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12071 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12082 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12100 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12116 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12138 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef enum _JOBOBJECTINFOCLASS { JobObjectBasicAccountingInformation = 1, JobObjectBasicLimitInformation, JobObjectBasicProcessIdList, JobObjectBasicUIRestrictions, JobObjectSecurityLimitInformation, JobObjectEndOfJobTimeInformation, JobObjectAssociateCompletionPortInformation, JobObjectBasicAndIoAccountingInformation, JobObjectExtendedLimitInformation, JobObjectJobSetInformation, JobObjectGroupInformation, JobObjectNotificationLimitInformation, JobObjectLimitViolationInformation, JobObjectGroupInformationEx, JobObjectCpuRateControlInformation, JobObjectCompletionFilter, JobObjectCompletionCounter, JobObjectReserved1Information = 18, JobObjectReserved2Information, JobObjectReserved3Information, JobObjectReserved4Information, JobObjectReserved5Information, JobObjectReserved6Information, JobObjectReserved7Information, JobObjectReserved8Information, JobObjectReserved9Information, JobObjectReserved10Information, JobObjectReserved11Information, JobObjectReserved12Information, JobObjectReserved13Information, JobObjectReserved14Information = 31, JobObjectNetRateControlInformation, JobObjectNotificationLimitInformation2, JobObjectLimitViolationInformation2, JobObjectCreateSilo, JobObjectSiloBasicInformation, JobObjectReserved15Information = 37, JobObjectReserved16Information = 38, JobObjectReserved17Information = 39, JobObjectReserved18Information = 40, JobObjectReserved19Information = 41, JobObjectReserved20Information = 42, JobObjectReserved21Information = 43, JobObjectReserved22Information = 44, JobObjectReserved23Information = 45, JobObjectReserved24Information = 46, JobObjectReserved25Information = 47, MaxJobObjectInfoClass } JOBOBJECTINFOCLASS; typedef struct _SILOOBJECT_BASIC_INFORMATION { DWORD SiloId; DWORD SiloParentId; DWORD NumberOfProcesses; BOOLEAN IsInServerSilo; BYTE Reserved[3]; } SILOOBJECT_BASIC_INFORMATION, *PSILOOBJECT_BASIC_INFORMATION; typedef enum _SERVERSILO_STATE { SERVERSILO_INITING = 0, SERVERSILO_STARTED, SERVERSILO_SHUTTING_DOWN, SERVERSILO_TERMINATING, SERVERSILO_TERMINATED, } SERVERSILO_STATE, *PSERVERSILO_STATE; typedef struct _SERVERSILO_BASIC_INFORMATION { DWORD ServiceSessionId; SERVERSILO_STATE State; DWORD ExitStatus; } SERVERSILO_BASIC_INFORMATION, *PSERVERSILO_BASIC_INFORMATION; typedef enum _FIRMWARE_TYPE { FirmwareTypeUnknown, FirmwareTypeBios, FirmwareTypeUefi, FirmwareTypeMax } FIRMWARE_TYPE, *PFIRMWARE_TYPE; typedef enum _LOGICAL_PROCESSOR_RELATIONSHIP { RelationProcessorCore, RelationNumaNode, RelationCache, RelationProcessorPackage, RelationGroup, RelationAll = 0xffff } LOGICAL_PROCESSOR_RELATIONSHIP; typedef enum _PROCESSOR_CACHE_TYPE { CacheUnified, CacheInstruction, CacheData, CacheTrace } PROCESSOR_CACHE_TYPE; typedef struct _CACHE_DESCRIPTOR { BYTE Level; BYTE Associativity; WORD LineSize; DWORD Size; PROCESSOR_CACHE_TYPE Type; } CACHE_DESCRIPTOR, *PCACHE_DESCRIPTOR; typedef struct _SYSTEM_LOGICAL_PROCESSOR_INFORMATION { ULONG_PTR ProcessorMask; LOGICAL_PROCESSOR_RELATIONSHIP Relationship; union { struct { BYTE Flags; } ProcessorCore; struct { DWORD NodeNumber; } NumaNode; CACHE_DESCRIPTOR Cache; ULONGLONG Reserved[2]; } ; } SYSTEM_LOGICAL_PROCESSOR_INFORMATION, *PSYSTEM_LOGICAL_PROCESSOR_INFORMATION; typedef struct _PROCESSOR_RELATIONSHIP { BYTE Flags; BYTE EfficiencyClass; BYTE Reserved[20]; WORD GroupCount; GROUP_AFFINITY GroupMask[1]; } PROCESSOR_RELATIONSHIP, *PPROCESSOR_RELATIONSHIP; typedef struct _NUMA_NODE_RELATIONSHIP { DWORD NodeNumber; BYTE Reserved[20]; GROUP_AFFINITY GroupMask; } NUMA_NODE_RELATIONSHIP, *PNUMA_NODE_RELATIONSHIP; typedef struct _CACHE_RELATIONSHIP { BYTE Level; BYTE Associativity; WORD LineSize; DWORD CacheSize; PROCESSOR_CACHE_TYPE Type; BYTE Reserved[20]; GROUP_AFFINITY GroupMask; } CACHE_RELATIONSHIP, *PCACHE_RELATIONSHIP; typedef struct _PROCESSOR_GROUP_INFO { BYTE MaximumProcessorCount; BYTE ActiveProcessorCount; BYTE Reserved[38]; KAFFINITY ActiveProcessorMask; } PROCESSOR_GROUP_INFO, *PPROCESSOR_GROUP_INFO; typedef struct _GROUP_RELATIONSHIP { WORD MaximumGroupCount; WORD ActiveGroupCount; BYTE Reserved[20]; PROCESSOR_GROUP_INFO GroupInfo[1]; } GROUP_RELATIONSHIP, *PGROUP_RELATIONSHIP; struct _SYSTEM_LOGICAL_PROCESSOR_INFORMATION_EX { LOGICAL_PROCESSOR_RELATIONSHIP Relationship; DWORD Size; union { PROCESSOR_RELATIONSHIP Processor; NUMA_NODE_RELATIONSHIP NumaNode; CACHE_RELATIONSHIP Cache; GROUP_RELATIONSHIP Group; } ; }; typedef struct _SYSTEM_LOGICAL_PROCESSOR_INFORMATION_EX SYSTEM_LOGICAL_PROCESSOR_INFORMATION_EX, *PSYSTEM_LOGICAL_PROCESSOR_INFORMATION_EX; typedef enum _CPU_SET_INFORMATION_TYPE { CpuSetInformation } CPU_SET_INFORMATION_TYPE, *PCPU_SET_INFORMATION_TYPE; struct _SYSTEM_CPU_SET_INFORMATION { DWORD Size; CPU_SET_INFORMATION_TYPE Type; union { struct { DWORD Id; WORD Group; BYTE LogicalProcessorIndex; BYTE CoreIndex; BYTE LastLevelCacheIndex; BYTE NumaNodeIndex; BYTE EfficiencyClass; union { BYTE AllFlags; struct { BYTE Parked : 1; BYTE Allocated : 1; BYTE AllocatedToTargetProcess : 1; BYTE RealTime : 1; BYTE ReservedFlags : 4; } ; } ; union { DWORD Reserved; BYTE SchedulingClass; }; DWORD64 AllocationTag; } CpuSet; } ; }; typedef struct _SYSTEM_CPU_SET_INFORMATION SYSTEM_CPU_SET_INFORMATION, *PSYSTEM_CPU_SET_INFORMATION; typedef struct _SYSTEM_PROCESSOR_CYCLE_TIME_INFORMATION { DWORD64 CycleTime; } SYSTEM_PROCESSOR_CYCLE_TIME_INFORMATION, *PSYSTEM_PROCESSOR_CYCLE_TIME_INFORMATION; #line 12423 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12439 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12475 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12506 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12534 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _XSTATE_FEATURE { DWORD Offset; DWORD Size; } XSTATE_FEATURE, *PXSTATE_FEATURE; typedef struct _XSTATE_CONFIGURATION { DWORD64 EnabledFeatures; DWORD64 EnabledVolatileFeatures; DWORD Size; union { DWORD ControlFlags; struct { DWORD OptimizedSave : 1; DWORD CompactionEnabled : 1; }; }; XSTATE_FEATURE Features[(64)]; DWORD64 EnabledSupervisorFeatures; DWORD64 AlignedFeatures; DWORD AllFeatureSize; DWORD AllFeatures[(64)]; } XSTATE_CONFIGURATION, *PXSTATE_CONFIGURATION; typedef struct _MEMORY_BASIC_INFORMATION { PVOID BaseAddress; PVOID AllocationBase; DWORD AllocationProtect; SIZE_T RegionSize; DWORD State; DWORD Protect; DWORD Type; } MEMORY_BASIC_INFORMATION, *PMEMORY_BASIC_INFORMATION; typedef struct _MEMORY_BASIC_INFORMATION32 { DWORD BaseAddress; DWORD AllocationBase; DWORD AllocationProtect; DWORD RegionSize; DWORD State; DWORD Protect; DWORD Type; } MEMORY_BASIC_INFORMATION32, *PMEMORY_BASIC_INFORMATION32; typedef struct __declspec(align(16)) _MEMORY_BASIC_INFORMATION64 { ULONGLONG BaseAddress; ULONGLONG AllocationBase; DWORD AllocationProtect; DWORD __alignment1; ULONGLONG RegionSize; DWORD State; DWORD Protect; DWORD Type; DWORD __alignment2; } MEMORY_BASIC_INFORMATION64, *PMEMORY_BASIC_INFORMATION64; typedef struct _CFG_CALL_TARGET_INFO { ULONG_PTR Offset; ULONG_PTR Flags; } CFG_CALL_TARGET_INFO, *PCFG_CALL_TARGET_INFO; #line 12674 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12730 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct MEM_ADDRESS_REQUIREMENTS { PVOID LowestStartingAddress; PVOID HighestEndingAddress; SIZE_T Alignment; } MEM_ADDRESS_REQUIREMENTS, *PMEM_ADDRESS_REQUIREMENTS; typedef enum MEM_EXTENDED_PARAMETER_TYPE { MemExtendedParameterInvalidType = 0, MemExtendedParameterAddressRequirements, MemExtendedParameterNumaNode, MemExtendedParameterPartitionHandle, MemExtendedParameterMax } MEM_EXTENDED_PARAMETER_TYPE, *PMEM_EXTENDED_PARAMETER_TYPE; typedef struct __declspec(align(8)) MEM_EXTENDED_PARAMETER { struct { DWORD64 Type : 8; DWORD64 Reserved : 64 - 8; } ; union { DWORD64 ULong64; PVOID Pointer; SIZE_T Size; HANDLE Handle; DWORD ULong; } ; } MEM_EXTENDED_PARAMETER, *PMEM_EXTENDED_PARAMETER; #line 12779 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _ENCLAVE_CREATE_INFO_SGX { BYTE Secs[4096]; } ENCLAVE_CREATE_INFO_SGX, *PENCLAVE_CREATE_INFO_SGX; typedef struct _ENCLAVE_INIT_INFO_SGX { BYTE SigStruct[1808]; BYTE Reserved1[240]; BYTE EInitToken[304]; BYTE Reserved2[1744]; } ENCLAVE_INIT_INFO_SGX, *PENCLAVE_INIT_INFO_SGX; typedef struct _ENCLAVE_CREATE_INFO_VBS { DWORD Flags; BYTE OwnerID[32]; } ENCLAVE_CREATE_INFO_VBS, *PENCLAVE_CREATE_INFO_VBS; typedef struct _ENCLAVE_INIT_INFO_VBS { DWORD Length; DWORD ThreadCount; } ENCLAVE_INIT_INFO_VBS, *PENCLAVE_INIT_INFO_VBS; typedef PVOID (ENCLAVE_TARGET_FUNCTION)(PVOID); typedef ENCLAVE_TARGET_FUNCTION (*PENCLAVE_TARGET_FUNCTION); typedef PENCLAVE_TARGET_FUNCTION LPENCLAVE_TARGET_FUNCTION; #line 12870 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12933 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 12953 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _FILE_ID_128 { BYTE Identifier[16]; } FILE_ID_128, *PFILE_ID_128; typedef struct _FILE_NOTIFY_INFORMATION { DWORD NextEntryOffset; DWORD Action; DWORD FileNameLength; WCHAR FileName[1]; } FILE_NOTIFY_INFORMATION, *PFILE_NOTIFY_INFORMATION; typedef struct _FILE_NOTIFY_EXTENDED_INFORMATION { DWORD NextEntryOffset; DWORD Action; LARGE_INTEGER CreationTime; LARGE_INTEGER LastModificationTime; LARGE_INTEGER LastChangeTime; LARGE_INTEGER LastAccessTime; LARGE_INTEGER AllocatedLength; LARGE_INTEGER FileSize; DWORD FileAttributes; DWORD ReparsePointTag; LARGE_INTEGER FileId; LARGE_INTEGER ParentFileId; DWORD FileNameLength; WCHAR FileName[1]; } FILE_NOTIFY_EXTENDED_INFORMATION, *PFILE_NOTIFY_EXTENDED_INFORMATION; typedef union _FILE_SEGMENT_ELEMENT { PVOID64 Buffer; ULONGLONG Alignment; }FILE_SEGMENT_ELEMENT, *PFILE_SEGMENT_ELEMENT; typedef struct _REPARSE_GUID_DATA_BUFFER { DWORD ReparseTag; WORD ReparseDataLength; WORD Reserved; GUID ReparseGuid; struct { BYTE DataBuffer[1]; } GenericReparseBuffer; } REPARSE_GUID_DATA_BUFFER, *PREPARSE_GUID_DATA_BUFFER; #line 13197 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 13208 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _SCRUB_DATA_INPUT { DWORD Size; DWORD Flags; DWORD MaximumIos; DWORD ObjectId[4]; DWORD Reserved[13]; BYTE ResumeContext[816]; } SCRUB_DATA_INPUT, *PSCRUB_DATA_INPUT; typedef struct _SCRUB_PARITY_EXTENT { LONGLONG Offset; ULONGLONG Length; } SCRUB_PARITY_EXTENT, *PSCRUB_PARITY_EXTENT; typedef struct _SCRUB_PARITY_EXTENT_DATA { WORD Size; WORD Flags; WORD NumberOfParityExtents; WORD MaximumNumberOfParityExtents; SCRUB_PARITY_EXTENT ParityExtents[1]; } SCRUB_PARITY_EXTENT_DATA, *PSCRUB_PARITY_EXTENT_DATA; typedef struct _SCRUB_DATA_OUTPUT { DWORD Size; DWORD Flags; DWORD Status; ULONGLONG ErrorFileOffset; ULONGLONG ErrorLength; ULONGLONG NumberOfBytesRepaired; ULONGLONG NumberOfBytesFailed; ULONGLONG InternalFileReference; WORD ResumeContextLength; WORD ParityExtentDataOffset; DWORD Reserved[5]; #line 13402 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" BYTE ResumeContext[816]; } SCRUB_DATA_OUTPUT, *PSCRUB_DATA_OUTPUT; typedef enum _SharedVirtualDiskSupportType { SharedVirtualDisksUnsupported = 0, SharedVirtualDisksSupported = 1, SharedVirtualDiskSnapshotsSupported = 3, SharedVirtualDiskCDPSnapshotsSupported = 7 } SharedVirtualDiskSupportType; typedef enum _SharedVirtualDiskHandleState { SharedVirtualDiskHandleStateNone = 0, SharedVirtualDiskHandleStateFileShared = 1, SharedVirtualDiskHandleStateHandleShared = 3 } SharedVirtualDiskHandleState; typedef struct _SHARED_VIRTUAL_DISK_SUPPORT { SharedVirtualDiskSupportType SharedVirtualDiskSupport; SharedVirtualDiskHandleState HandleState; } SHARED_VIRTUAL_DISK_SUPPORT, *PSHARED_VIRTUAL_DISK_SUPPORT; typedef struct _NETWORK_APP_INSTANCE_EA { GUID AppInstanceID; DWORD CsvFlags; } NETWORK_APP_INSTANCE_EA, *PNETWORK_APP_INSTANCE_EA; extern const GUID GUID_MAX_POWER_SAVINGS; extern const GUID GUID_MIN_POWER_SAVINGS; extern const GUID GUID_TYPICAL_POWER_SAVINGS; extern const GUID NO_SUBGROUP_GUID; extern const GUID ALL_POWERSCHEMES_GUID; extern const GUID GUID_POWERSCHEME_PERSONALITY; extern const GUID GUID_ACTIVE_POWERSCHEME; extern const GUID GUID_IDLE_RESILIENCY_SUBGROUP; extern const GUID GUID_IDLE_RESILIENCY_PERIOD; extern const GUID GUID_DEEP_SLEEP_ENABLED; extern const GUID GUID_DEEP_SLEEP_PLATFORM_STATE; extern const GUID GUID_DISK_COALESCING_POWERDOWN_TIMEOUT; extern const GUID GUID_EXECUTION_REQUIRED_REQUEST_TIMEOUT; extern const GUID GUID_VIDEO_SUBGROUP; extern const GUID GUID_VIDEO_POWERDOWN_TIMEOUT; extern const GUID GUID_VIDEO_ANNOYANCE_TIMEOUT; extern const GUID GUID_VIDEO_ADAPTIVE_PERCENT_INCREASE; extern const GUID GUID_VIDEO_DIM_TIMEOUT; extern const GUID GUID_VIDEO_ADAPTIVE_POWERDOWN; extern const GUID GUID_MONITOR_POWER_ON; extern const GUID GUID_DEVICE_POWER_POLICY_VIDEO_BRIGHTNESS; extern const GUID GUID_DEVICE_POWER_POLICY_VIDEO_DIM_BRIGHTNESS; extern const GUID GUID_VIDEO_CURRENT_MONITOR_BRIGHTNESS; extern const GUID GUID_VIDEO_ADAPTIVE_DISPLAY_BRIGHTNESS; extern const GUID GUID_CONSOLE_DISPLAY_STATE; extern const GUID GUID_ALLOW_DISPLAY_REQUIRED; extern const GUID GUID_VIDEO_CONSOLE_LOCK_TIMEOUT; extern const GUID GUID_ADAPTIVE_POWER_BEHAVIOR_SUBGROUP; extern const GUID GUID_NON_ADAPTIVE_INPUT_TIMEOUT; extern const GUID GUID_ADAPTIVE_INPUT_CONTROLLER_STATE; extern const GUID GUID_DISK_SUBGROUP; extern const GUID GUID_DISK_MAX_POWER; extern const GUID GUID_DISK_POWERDOWN_TIMEOUT; extern const GUID GUID_DISK_IDLE_TIMEOUT; extern const GUID GUID_DISK_BURST_IGNORE_THRESHOLD; extern const GUID GUID_DISK_ADAPTIVE_POWERDOWN; extern const GUID GUID_SLEEP_SUBGROUP; extern const GUID GUID_SLEEP_IDLE_THRESHOLD; extern const GUID GUID_STANDBY_TIMEOUT; extern const GUID GUID_UNATTEND_SLEEP_TIMEOUT; extern const GUID GUID_HIBERNATE_TIMEOUT; extern const GUID GUID_HIBERNATE_FASTS4_POLICY; extern const GUID GUID_CRITICAL_POWER_TRANSITION; extern const GUID GUID_SYSTEM_AWAYMODE; extern const GUID GUID_ALLOW_AWAYMODE; extern const GUID GUID_USER_PRESENCE_PREDICTION; extern const GUID GUID_STANDBY_BUDGET_GRACE_PERIOD; extern const GUID GUID_STANDBY_BUDGET_PERCENT; extern const GUID GUID_STANDBY_RESERVE_GRACE_PERIOD; extern const GUID GUID_STANDBY_RESERVE_TIME; extern const GUID GUID_STANDBY_RESET_PERCENT; extern const GUID GUID_ALLOW_STANDBY_STATES; extern const GUID GUID_ALLOW_RTC_WAKE; extern const GUID GUID_LEGACY_RTC_MITIGATION; extern const GUID GUID_ALLOW_SYSTEM_REQUIRED; extern const GUID GUID_POWER_SAVING_STATUS; extern const GUID GUID_ENERGY_SAVER_SUBGROUP; extern const GUID GUID_ENERGY_SAVER_BATTERY_THRESHOLD; extern const GUID GUID_ENERGY_SAVER_BRIGHTNESS; extern const GUID GUID_ENERGY_SAVER_POLICY; extern const GUID GUID_SYSTEM_BUTTON_SUBGROUP; extern const GUID GUID_POWERBUTTON_ACTION; extern const GUID GUID_SLEEPBUTTON_ACTION; extern const GUID GUID_USERINTERFACEBUTTON_ACTION; extern const GUID GUID_LIDCLOSE_ACTION; extern const GUID GUID_LIDOPEN_POWERSTATE; extern const GUID GUID_BATTERY_SUBGROUP; extern const GUID GUID_BATTERY_DISCHARGE_ACTION_0; extern const GUID GUID_BATTERY_DISCHARGE_LEVEL_0; extern const GUID GUID_BATTERY_DISCHARGE_FLAGS_0; extern const GUID GUID_BATTERY_DISCHARGE_ACTION_1; extern const GUID GUID_BATTERY_DISCHARGE_LEVEL_1; extern const GUID GUID_BATTERY_DISCHARGE_FLAGS_1; extern const GUID GUID_BATTERY_DISCHARGE_ACTION_2; extern const GUID GUID_BATTERY_DISCHARGE_LEVEL_2; extern const GUID GUID_BATTERY_DISCHARGE_FLAGS_2; extern const GUID GUID_BATTERY_DISCHARGE_ACTION_3; extern const GUID GUID_BATTERY_DISCHARGE_LEVEL_3; extern const GUID GUID_BATTERY_DISCHARGE_FLAGS_3; extern const GUID GUID_PROCESSOR_SETTINGS_SUBGROUP; extern const GUID GUID_PROCESSOR_THROTTLE_POLICY; extern const GUID GUID_PROCESSOR_THROTTLE_MAXIMUM; extern const GUID GUID_PROCESSOR_THROTTLE_MAXIMUM_1; extern const GUID GUID_PROCESSOR_THROTTLE_MINIMUM; extern const GUID GUID_PROCESSOR_THROTTLE_MINIMUM_1; extern const GUID GUID_PROCESSOR_FREQUENCY_LIMIT; extern const GUID GUID_PROCESSOR_FREQUENCY_LIMIT_1; extern const GUID GUID_PROCESSOR_ALLOW_THROTTLING; extern const GUID GUID_PROCESSOR_IDLESTATE_POLICY; extern const GUID GUID_PROCESSOR_PERFSTATE_POLICY; extern const GUID GUID_PROCESSOR_PERF_INCREASE_THRESHOLD; extern const GUID GUID_PROCESSOR_PERF_INCREASE_THRESHOLD_1; extern const GUID GUID_PROCESSOR_PERF_DECREASE_THRESHOLD; extern const GUID GUID_PROCESSOR_PERF_DECREASE_THRESHOLD_1; extern const GUID GUID_PROCESSOR_PERF_INCREASE_POLICY; extern const GUID GUID_PROCESSOR_PERF_INCREASE_POLICY_1; extern const GUID GUID_PROCESSOR_PERF_DECREASE_POLICY; extern const GUID GUID_PROCESSOR_PERF_DECREASE_POLICY_1; extern const GUID GUID_PROCESSOR_PERF_INCREASE_TIME; extern const GUID GUID_PROCESSOR_PERF_INCREASE_TIME_1; extern const GUID GUID_PROCESSOR_PERF_DECREASE_TIME; extern const GUID GUID_PROCESSOR_PERF_DECREASE_TIME_1; extern const GUID GUID_PROCESSOR_PERF_TIME_CHECK; extern const GUID GUID_PROCESSOR_PERF_BOOST_POLICY; extern const GUID GUID_PROCESSOR_PERF_BOOST_MODE; #line 14399 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" extern const GUID GUID_PROCESSOR_PERF_AUTONOMOUS_MODE; extern const GUID GUID_PROCESSOR_PERF_ENERGY_PERFORMANCE_PREFERENCE; extern const GUID GUID_PROCESSOR_PERF_AUTONOMOUS_ACTIVITY_WINDOW; extern const GUID GUID_PROCESSOR_DUTY_CYCLING; extern const GUID GUID_PROCESSOR_IDLE_ALLOW_SCALING; extern const GUID GUID_PROCESSOR_IDLE_DISABLE; extern const GUID GUID_PROCESSOR_IDLE_STATE_MAXIMUM; extern const GUID GUID_PROCESSOR_IDLE_TIME_CHECK; extern const GUID GUID_PROCESSOR_IDLE_DEMOTE_THRESHOLD; extern const GUID GUID_PROCESSOR_IDLE_PROMOTE_THRESHOLD; extern const GUID GUID_PROCESSOR_CORE_PARKING_INCREASE_THRESHOLD; extern const GUID GUID_PROCESSOR_CORE_PARKING_DECREASE_THRESHOLD; extern const GUID GUID_PROCESSOR_CORE_PARKING_INCREASE_POLICY; extern const GUID GUID_PROCESSOR_CORE_PARKING_DECREASE_POLICY; extern const GUID GUID_PROCESSOR_CORE_PARKING_MAX_CORES; extern const GUID GUID_PROCESSOR_CORE_PARKING_MAX_CORES_1; extern const GUID GUID_PROCESSOR_CORE_PARKING_MIN_CORES; extern const GUID GUID_PROCESSOR_CORE_PARKING_MIN_CORES_1; extern const GUID GUID_PROCESSOR_CORE_PARKING_INCREASE_TIME; extern const GUID GUID_PROCESSOR_CORE_PARKING_DECREASE_TIME; extern const GUID GUID_PROCESSOR_CORE_PARKING_AFFINITY_HISTORY_DECREASE_FACTOR; extern const GUID GUID_PROCESSOR_CORE_PARKING_AFFINITY_HISTORY_THRESHOLD; extern const GUID GUID_PROCESSOR_CORE_PARKING_AFFINITY_WEIGHTING; extern const GUID GUID_PROCESSOR_CORE_PARKING_OVER_UTILIZATION_HISTORY_DECREASE_FACTOR; extern const GUID GUID_PROCESSOR_CORE_PARKING_OVER_UTILIZATION_HISTORY_THRESHOLD; extern const GUID GUID_PROCESSOR_CORE_PARKING_OVER_UTILIZATION_WEIGHTING; extern const GUID GUID_PROCESSOR_CORE_PARKING_OVER_UTILIZATION_THRESHOLD; extern const GUID GUID_PROCESSOR_PARKING_CORE_OVERRIDE; extern const GUID GUID_PROCESSOR_PARKING_PERF_STATE; extern const GUID GUID_PROCESSOR_PARKING_PERF_STATE_1; extern const GUID GUID_PROCESSOR_PARKING_CONCURRENCY_THRESHOLD; extern const GUID GUID_PROCESSOR_PARKING_HEADROOM_THRESHOLD; extern const GUID GUID_PROCESSOR_PARKING_DISTRIBUTION_THRESHOLD; extern const GUID GUID_PROCESSOR_PERF_HISTORY; extern const GUID GUID_PROCESSOR_PERF_HISTORY_1; extern const GUID GUID_PROCESSOR_PERF_INCREASE_HISTORY; extern const GUID GUID_PROCESSOR_PERF_DECREASE_HISTORY; extern const GUID GUID_PROCESSOR_PERF_CORE_PARKING_HISTORY; extern const GUID GUID_PROCESSOR_PERF_LATENCY_HINT; extern const GUID GUID_PROCESSOR_PERF_LATENCY_HINT_PERF; extern const GUID GUID_PROCESSOR_PERF_LATENCY_HINT_PERF_1; extern const GUID GUID_PROCESSOR_LATENCY_HINT_MIN_UNPARK; extern const GUID GUID_PROCESSOR_LATENCY_HINT_MIN_UNPARK_1; extern const GUID GUID_PROCESSOR_DISTRIBUTE_UTILITY; extern const GUID GUID_PROCESSOR_HETEROGENEOUS_POLICY; extern const GUID GUID_PROCESSOR_HETERO_DECREASE_TIME; extern const GUID GUID_PROCESSOR_HETERO_INCREASE_TIME; extern const GUID GUID_PROCESSOR_HETERO_DECREASE_THRESHOLD; extern const GUID GUID_PROCESSOR_HETERO_INCREASE_THRESHOLD; extern const GUID GUID_PROCESSOR_CLASS0_FLOOR_PERF; extern const GUID GUID_PROCESSOR_CLASS1_INITIAL_PERF; extern const GUID GUID_PROCESSOR_THREAD_SCHEDULING_POLICY; extern const GUID GUID_PROCESSOR_SHORT_THREAD_SCHEDULING_POLICY; extern const GUID GUID_SYSTEM_COOLING_POLICY; extern const GUID GUID_LOCK_CONSOLE_ON_WAKE; extern const GUID GUID_DEVICE_IDLE_POLICY; extern const GUID GUID_CONNECTIVITY_IN_STANDBY; extern const GUID GUID_DISCONNECTED_STANDBY_MODE; extern const GUID GUID_ACDC_POWER_SOURCE; extern const GUID GUID_LIDSWITCH_STATE_CHANGE; extern const GUID GUID_BATTERY_PERCENTAGE_REMAINING; extern const GUID GUID_BATTERY_COUNT; extern const GUID GUID_GLOBAL_USER_PRESENCE; extern const GUID GUID_SESSION_DISPLAY_STATUS; extern const GUID GUID_SESSION_USER_PRESENCE; extern const GUID GUID_IDLE_BACKGROUND_TASK; extern const GUID GUID_BACKGROUND_TASK_NOTIFICATION; extern const GUID GUID_APPLAUNCH_BUTTON; extern const GUID GUID_PCIEXPRESS_SETTINGS_SUBGROUP; extern const GUID GUID_PCIEXPRESS_ASPM_POLICY; extern const GUID GUID_ENABLE_SWITCH_FORCED_SHUTDOWN; extern const GUID GUID_INTSTEER_SUBGROUP; extern const GUID GUID_INTSTEER_MODE; extern const GUID GUID_INTSTEER_LOAD_PER_PROC_TRIGGER; extern const GUID GUID_INTSTEER_TIME_UNPARK_TRIGGER; extern const GUID GUID_GRAPHICS_SUBGROUP; extern const GUID GUID_GPU_PREFERENCE_POLICY; extern const GUID GUID_MIXED_REALITY_MODE; extern const GUID GUID_SPR_ACTIVE_SESSION_CHANGE; typedef enum _SYSTEM_POWER_STATE { PowerSystemUnspecified = 0, PowerSystemWorking = 1, PowerSystemSleeping1 = 2, PowerSystemSleeping2 = 3, PowerSystemSleeping3 = 4, PowerSystemHibernate = 5, PowerSystemShutdown = 6, PowerSystemMaximum = 7 } SYSTEM_POWER_STATE, *PSYSTEM_POWER_STATE; typedef enum { PowerActionNone = 0, PowerActionReserved, PowerActionSleep, PowerActionHibernate, PowerActionShutdown, PowerActionShutdownReset, PowerActionShutdownOff, PowerActionWarmEject, PowerActionDisplayOff } POWER_ACTION, *PPOWER_ACTION; typedef enum _DEVICE_POWER_STATE { PowerDeviceUnspecified = 0, PowerDeviceD0, PowerDeviceD1, PowerDeviceD2, PowerDeviceD3, PowerDeviceMaximum } DEVICE_POWER_STATE, *PDEVICE_POWER_STATE; typedef enum _MONITOR_DISPLAY_STATE { PowerMonitorOff = 0, PowerMonitorOn, PowerMonitorDim } MONITOR_DISPLAY_STATE, *PMONITOR_DISPLAY_STATE; typedef enum _USER_ACTIVITY_PRESENCE { PowerUserPresent = 0, PowerUserNotPresent, PowerUserInactive, PowerUserMaximum, PowerUserInvalid = PowerUserMaximum } USER_ACTIVITY_PRESENCE, *PUSER_ACTIVITY_PRESENCE; typedef DWORD EXECUTION_STATE, *PEXECUTION_STATE; typedef enum { LT_DONT_CARE, LT_LOWEST_LATENCY } LATENCY_TIME; typedef enum _POWER_REQUEST_TYPE { PowerRequestDisplayRequired, PowerRequestSystemRequired, PowerRequestAwayModeRequired, PowerRequestExecutionRequired } POWER_REQUEST_TYPE, *PPOWER_REQUEST_TYPE; #line 15202 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct CM_Power_Data_s { DWORD PD_Size; DEVICE_POWER_STATE PD_MostRecentPowerState; DWORD PD_Capabilities; DWORD PD_D1Latency; DWORD PD_D2Latency; DWORD PD_D3Latency; DEVICE_POWER_STATE PD_PowerStateMapping[7]; SYSTEM_POWER_STATE PD_DeepestSystemWake; } CM_POWER_DATA, *PCM_POWER_DATA; typedef enum { SystemPowerPolicyAc, SystemPowerPolicyDc, VerifySystemPolicyAc, VerifySystemPolicyDc, SystemPowerCapabilities, SystemBatteryState, SystemPowerStateHandler, ProcessorStateHandler, SystemPowerPolicyCurrent, AdministratorPowerPolicy, SystemReserveHiberFile, ProcessorInformation, SystemPowerInformation, ProcessorStateHandler2, LastWakeTime, LastSleepTime, SystemExecutionState, SystemPowerStateNotifyHandler, ProcessorPowerPolicyAc, ProcessorPowerPolicyDc, VerifyProcessorPowerPolicyAc, VerifyProcessorPowerPolicyDc, ProcessorPowerPolicyCurrent, SystemPowerStateLogging, SystemPowerLoggingEntry, SetPowerSettingValue, NotifyUserPowerSetting, PowerInformationLevelUnused0, SystemMonitorHiberBootPowerOff, SystemVideoState, TraceApplicationPowerMessage, TraceApplicationPowerMessageEnd, ProcessorPerfStates, ProcessorIdleStates, ProcessorCap, SystemWakeSource, SystemHiberFileInformation, TraceServicePowerMessage, ProcessorLoad, PowerShutdownNotification, MonitorCapabilities, SessionPowerInit, SessionDisplayState, PowerRequestCreate, PowerRequestAction, GetPowerRequestList, ProcessorInformationEx, NotifyUserModeLegacyPowerEvent, GroupPark, ProcessorIdleDomains, WakeTimerList, SystemHiberFileSize, ProcessorIdleStatesHv, ProcessorPerfStatesHv, ProcessorPerfCapHv, ProcessorSetIdle, LogicalProcessorIdling, UserPresence, PowerSettingNotificationName, GetPowerSettingValue, IdleResiliency, SessionRITState, SessionConnectNotification, SessionPowerCleanup, SessionLockState, SystemHiberbootState, PlatformInformation, PdcInvocation, MonitorInvocation, FirmwareTableInformationRegistered, SetShutdownSelectedTime, SuspendResumeInvocation, PlmPowerRequestCreate, ScreenOff, CsDeviceNotification, PlatformRole, LastResumePerformance, DisplayBurst, ExitLatencySamplingPercentage, RegisterSpmPowerSettings, PlatformIdleStates, ProcessorIdleVeto, PlatformIdleVeto, SystemBatteryStatePrecise, ThermalEvent, PowerRequestActionInternal, BatteryDeviceState, PowerInformationInternal, ThermalStandby, SystemHiberFileType, PhysicalPowerButtonPress, QueryPotentialDripsConstraint, EnergyTrackerCreate, EnergyTrackerQuery, UpdateBlackBoxRecorder, PowerInformationLevelMaximum } POWER_INFORMATION_LEVEL; typedef enum { UserNotPresent = 0, UserPresent = 1, UserUnknown = 0xff } POWER_USER_PRESENCE_TYPE, *PPOWER_USER_PRESENCE_TYPE; typedef struct _POWER_USER_PRESENCE { POWER_USER_PRESENCE_TYPE UserPresence; } POWER_USER_PRESENCE, *PPOWER_USER_PRESENCE; typedef struct _POWER_SESSION_CONNECT { BOOLEAN Connected; BOOLEAN Console; } POWER_SESSION_CONNECT, *PPOWER_SESSION_CONNECT; typedef struct _POWER_SESSION_TIMEOUTS { DWORD InputTimeout; DWORD DisplayTimeout; } POWER_SESSION_TIMEOUTS, *PPOWER_SESSION_TIMEOUTS; typedef struct _POWER_SESSION_RIT_STATE { BOOLEAN Active; DWORD LastInputTime; } POWER_SESSION_RIT_STATE, *PPOWER_SESSION_RIT_STATE; typedef struct _POWER_SESSION_WINLOGON { DWORD SessionId; BOOLEAN Console; BOOLEAN Locked; } POWER_SESSION_WINLOGON, *PPOWER_SESSION_WINLOGON; typedef struct _POWER_IDLE_RESILIENCY { DWORD CoalescingTimeout; DWORD IdleResiliencyPeriod; } POWER_IDLE_RESILIENCY, *PPOWER_IDLE_RESILIENCY; typedef enum { MonitorRequestReasonUnknown, MonitorRequestReasonPowerButton, MonitorRequestReasonRemoteConnection, MonitorRequestReasonScMonitorpower, MonitorRequestReasonUserInput, MonitorRequestReasonAcDcDisplayBurst, MonitorRequestReasonUserDisplayBurst, MonitorRequestReasonPoSetSystemState, MonitorRequestReasonSetThreadExecutionState, MonitorRequestReasonFullWake, MonitorRequestReasonSessionUnlock, MonitorRequestReasonScreenOffRequest, MonitorRequestReasonIdleTimeout, MonitorRequestReasonPolicyChange, MonitorRequestReasonSleepButton, MonitorRequestReasonLid, MonitorRequestReasonBatteryCountChange, MonitorRequestReasonGracePeriod, MonitorRequestReasonPnP, MonitorRequestReasonDP, MonitorRequestReasonSxTransition, MonitorRequestReasonSystemIdle, MonitorRequestReasonNearProximity, MonitorRequestReasonThermalStandby, MonitorRequestReasonResumePdc, MonitorRequestReasonResumeS4, MonitorRequestReasonTerminal, MonitorRequestReasonPdcSignal, MonitorRequestReasonAcDcDisplayBurstSuppressed, MonitorRequestReasonSystemStateEntered, MonitorRequestReasonWinrt, MonitorRequestReasonUserInputKeyboard, MonitorRequestReasonUserInputMouse, MonitorRequestReasonUserInputTouch, MonitorRequestReasonUserInputPen, MonitorRequestReasonUserInputAccelerometer, MonitorRequestReasonUserInputHid, MonitorRequestReasonUserInputPoUserPresent, MonitorRequestReasonUserInputSessionSwitch, MonitorRequestReasonUserInputInitialization, MonitorRequestReasonPdcSignalWindowsMobilePwrNotif, MonitorRequestReasonPdcSignalWindowsMobileShell, MonitorRequestReasonPdcSignalHeyCortana, MonitorRequestReasonPdcSignalHolographicShell, MonitorRequestReasonPdcSignalFingerprint, MonitorRequestReasonMax } POWER_MONITOR_REQUEST_REASON; typedef enum _POWER_MONITOR_REQUEST_TYPE { MonitorRequestTypeOff, MonitorRequestTypeOnAndPresent, MonitorRequestTypeToggleOn } POWER_MONITOR_REQUEST_TYPE; typedef struct _POWER_MONITOR_INVOCATION { BOOLEAN Console; POWER_MONITOR_REQUEST_REASON RequestReason; } POWER_MONITOR_INVOCATION, *PPOWER_MONITOR_INVOCATION; typedef struct _RESUME_PERFORMANCE { DWORD PostTimeMs; ULONGLONG TotalResumeTimeMs; ULONGLONG ResumeCompleteTimestamp; } RESUME_PERFORMANCE, *PRESUME_PERFORMANCE; typedef enum { PoAc, PoDc, PoHot, PoConditionMaximum } SYSTEM_POWER_CONDITION; typedef struct { DWORD Version; GUID Guid; SYSTEM_POWER_CONDITION PowerCondition; DWORD DataLength; BYTE Data[1]; } SET_POWER_SETTING_VALUE, *PSET_POWER_SETTING_VALUE; typedef struct { GUID Guid; } NOTIFY_USER_POWER_SETTING, *PNOTIFY_USER_POWER_SETTING; typedef struct _APPLICATIONLAUNCH_SETTING_VALUE { LARGE_INTEGER ActivationTime; DWORD Flags; DWORD ButtonInstanceID; } APPLICATIONLAUNCH_SETTING_VALUE, *PAPPLICATIONLAUNCH_SETTING_VALUE; typedef enum _POWER_PLATFORM_ROLE { PlatformRoleUnspecified = 0, PlatformRoleDesktop, PlatformRoleMobile, PlatformRoleWorkstation, PlatformRoleEnterpriseServer, PlatformRoleSOHOServer, PlatformRoleAppliancePC, PlatformRolePerformanceServer, PlatformRoleSlate, PlatformRoleMaximum } POWER_PLATFORM_ROLE, *PPOWER_PLATFORM_ROLE; #line 15558 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _POWER_PLATFORM_INFORMATION { BOOLEAN AoAc; } POWER_PLATFORM_INFORMATION, *PPOWER_PLATFORM_INFORMATION; typedef struct { DWORD Granularity; DWORD Capacity; } BATTERY_REPORTING_SCALE, *PBATTERY_REPORTING_SCALE; typedef struct { DWORD Frequency; DWORD Flags; DWORD PercentFrequency; } PPM_WMI_LEGACY_PERFSTATE, *PPPM_WMI_LEGACY_PERFSTATE; typedef struct { DWORD Latency; DWORD Power; DWORD TimeCheck; BYTE PromotePercent; BYTE DemotePercent; BYTE StateType; BYTE Reserved; DWORD StateFlags; DWORD Context; DWORD IdleHandler; DWORD Reserved1; } PPM_WMI_IDLE_STATE, *PPPM_WMI_IDLE_STATE; typedef struct { DWORD Type; DWORD Count; DWORD TargetState; DWORD OldState; DWORD64 TargetProcessors; PPM_WMI_IDLE_STATE State[1]; } PPM_WMI_IDLE_STATES, *PPPM_WMI_IDLE_STATES; typedef struct { DWORD Type; DWORD Count; DWORD TargetState; DWORD OldState; PVOID TargetProcessors; PPM_WMI_IDLE_STATE State[1]; } PPM_WMI_IDLE_STATES_EX, *PPPM_WMI_IDLE_STATES_EX; typedef struct { DWORD Frequency; DWORD Power; BYTE PercentFrequency; BYTE IncreaseLevel; BYTE DecreaseLevel; BYTE Type; DWORD IncreaseTime; DWORD DecreaseTime; DWORD64 Control; DWORD64 Status; DWORD HitCount; DWORD Reserved1; DWORD64 Reserved2; DWORD64 Reserved3; } PPM_WMI_PERF_STATE, *PPPM_WMI_PERF_STATE; typedef struct { DWORD Count; DWORD MaxFrequency; DWORD CurrentState; DWORD MaxPerfState; DWORD MinPerfState; DWORD LowestPerfState; DWORD ThermalConstraint; BYTE BusyAdjThreshold; BYTE PolicyType; BYTE Type; BYTE Reserved; DWORD TimerInterval; DWORD64 TargetProcessors; DWORD PStateHandler; DWORD PStateContext; DWORD TStateHandler; DWORD TStateContext; DWORD FeedbackHandler; DWORD Reserved1; DWORD64 Reserved2; PPM_WMI_PERF_STATE State[1]; } PPM_WMI_PERF_STATES, *PPPM_WMI_PERF_STATES; typedef struct { DWORD Count; DWORD MaxFrequency; DWORD CurrentState; DWORD MaxPerfState; DWORD MinPerfState; DWORD LowestPerfState; DWORD ThermalConstraint; BYTE BusyAdjThreshold; BYTE PolicyType; BYTE Type; BYTE Reserved; DWORD TimerInterval; PVOID TargetProcessors; DWORD PStateHandler; DWORD PStateContext; DWORD TStateHandler; DWORD TStateContext; DWORD FeedbackHandler; DWORD Reserved1; DWORD64 Reserved2; PPM_WMI_PERF_STATE State[1]; } PPM_WMI_PERF_STATES_EX, *PPPM_WMI_PERF_STATES_EX; typedef struct { DWORD IdleTransitions; DWORD FailedTransitions; DWORD InvalidBucketIndex; DWORD64 TotalTime; DWORD IdleTimeBuckets[6]; } PPM_IDLE_STATE_ACCOUNTING, *PPPM_IDLE_STATE_ACCOUNTING; typedef struct { DWORD StateCount; DWORD TotalTransitions; DWORD ResetCount; DWORD64 StartTime; PPM_IDLE_STATE_ACCOUNTING State[1]; } PPM_IDLE_ACCOUNTING, *PPPM_IDLE_ACCOUNTING; typedef struct { DWORD64 TotalTimeUs; DWORD MinTimeUs; DWORD MaxTimeUs; DWORD Count; } PPM_IDLE_STATE_BUCKET_EX, *PPPM_IDLE_STATE_BUCKET_EX; typedef struct { DWORD64 TotalTime; DWORD IdleTransitions; DWORD FailedTransitions; DWORD InvalidBucketIndex; DWORD MinTimeUs; DWORD MaxTimeUs; DWORD CancelledTransitions; PPM_IDLE_STATE_BUCKET_EX IdleTimeBuckets[16]; } PPM_IDLE_STATE_ACCOUNTING_EX, *PPPM_IDLE_STATE_ACCOUNTING_EX; typedef struct { DWORD StateCount; DWORD TotalTransitions; DWORD ResetCount; DWORD AbortCount; DWORD64 StartTime; PPM_IDLE_STATE_ACCOUNTING_EX State[1]; } PPM_IDLE_ACCOUNTING_EX, *PPPM_IDLE_ACCOUNTING_EX; #line 15773 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" extern const GUID PPM_PERFSTATE_CHANGE_GUID; extern const GUID PPM_PERFSTATE_DOMAIN_CHANGE_GUID; extern const GUID PPM_IDLESTATE_CHANGE_GUID; extern const GUID PPM_PERFSTATES_DATA_GUID; extern const GUID PPM_IDLESTATES_DATA_GUID; extern const GUID PPM_IDLE_ACCOUNTING_GUID; extern const GUID PPM_IDLE_ACCOUNTING_EX_GUID; extern const GUID PPM_THERMALCONSTRAINT_GUID; extern const GUID PPM_PERFMON_PERFSTATE_GUID; extern const GUID PPM_THERMAL_POLICY_CHANGE_GUID; typedef struct { DWORD State; DWORD Status; DWORD Latency; DWORD Speed; DWORD Processor; } PPM_PERFSTATE_EVENT, *PPPM_PERFSTATE_EVENT; typedef struct { DWORD State; DWORD Latency; DWORD Speed; DWORD64 Processors; } PPM_PERFSTATE_DOMAIN_EVENT, *PPPM_PERFSTATE_DOMAIN_EVENT; typedef struct { DWORD NewState; DWORD OldState; DWORD64 Processors; } PPM_IDLESTATE_EVENT, *PPPM_IDLESTATE_EVENT; typedef struct { DWORD ThermalConstraint; DWORD64 Processors; } PPM_THERMALCHANGE_EVENT, *PPPM_THERMALCHANGE_EVENT; #pragma warning(push) #pragma warning(disable:4121) typedef struct { BYTE Mode; DWORD64 Processors; } PPM_THERMAL_POLICY_EVENT, *PPPM_THERMAL_POLICY_EVENT; #pragma warning(pop) typedef struct { POWER_ACTION Action; DWORD Flags; DWORD EventCode; } POWER_ACTION_POLICY, *PPOWER_ACTION_POLICY; #line 15895 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 15904 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct { BOOLEAN Enable; BYTE Spare[3]; DWORD BatteryLevel; POWER_ACTION_POLICY PowerPolicy; SYSTEM_POWER_STATE MinSystemState; } SYSTEM_POWER_LEVEL, *PSYSTEM_POWER_LEVEL; typedef struct _SYSTEM_POWER_POLICY { DWORD Revision; POWER_ACTION_POLICY PowerButton; POWER_ACTION_POLICY SleepButton; POWER_ACTION_POLICY LidClose; SYSTEM_POWER_STATE LidOpenWake; DWORD Reserved; POWER_ACTION_POLICY Idle; DWORD IdleTimeout; BYTE IdleSensitivity; BYTE DynamicThrottle; BYTE Spare2[2]; SYSTEM_POWER_STATE MinSleep; SYSTEM_POWER_STATE MaxSleep; SYSTEM_POWER_STATE ReducedLatencySleep; DWORD WinLogonFlags; DWORD Spare3; DWORD DozeS4Timeout; DWORD BroadcastCapacityResolution; SYSTEM_POWER_LEVEL DischargePolicy[4]; DWORD VideoTimeout; BOOLEAN VideoDimDisplay; DWORD VideoReserved[3]; DWORD SpindownTimeout; BOOLEAN OptimizeForPower; BYTE FanThrottleTolerance; BYTE ForcedThrottle; BYTE MinThrottle; POWER_ACTION_POLICY OverThrottled; } SYSTEM_POWER_POLICY, *PSYSTEM_POWER_POLICY; typedef struct { DWORD TimeCheck; BYTE DemotePercent; BYTE PromotePercent; BYTE Spare[2]; } PROCESSOR_IDLESTATE_INFO, *PPROCESSOR_IDLESTATE_INFO; typedef struct { WORD Revision; union { WORD AsWORD ; struct { WORD AllowScaling : 1; WORD Disabled : 1; WORD Reserved : 14; } ; } Flags; DWORD PolicyCount; PROCESSOR_IDLESTATE_INFO Policy[0x3]; } PROCESSOR_IDLESTATE_POLICY, *PPROCESSOR_IDLESTATE_POLICY; typedef struct _PROCESSOR_POWER_POLICY_INFO { DWORD TimeCheck; DWORD DemoteLimit; DWORD PromoteLimit; BYTE DemotePercent; BYTE PromotePercent; BYTE Spare[2]; DWORD AllowDemotion:1; DWORD AllowPromotion:1; DWORD Reserved:30; } PROCESSOR_POWER_POLICY_INFO, *PPROCESSOR_POWER_POLICY_INFO; typedef struct _PROCESSOR_POWER_POLICY { DWORD Revision; BYTE DynamicThrottle; BYTE Spare[3]; DWORD DisableCStates:1; DWORD Reserved:31; DWORD PolicyCount; PROCESSOR_POWER_POLICY_INFO Policy[3]; } PROCESSOR_POWER_POLICY, *PPROCESSOR_POWER_POLICY; typedef struct { DWORD Revision; BYTE MaxThrottle; BYTE MinThrottle; BYTE BusyAdjThreshold; union { BYTE Spare; union { BYTE AsBYTE ; struct { BYTE NoDomainAccounting : 1; BYTE IncreasePolicy: 2; BYTE DecreasePolicy: 2; BYTE Reserved : 3; } ; } Flags; } ; DWORD TimeCheck; DWORD IncreaseTime; DWORD DecreaseTime; DWORD IncreasePercent; DWORD DecreasePercent; } PROCESSOR_PERFSTATE_POLICY, *PPROCESSOR_PERFSTATE_POLICY; typedef struct _ADMINISTRATOR_POWER_POLICY { SYSTEM_POWER_STATE MinSleep; SYSTEM_POWER_STATE MaxSleep; DWORD MinVideoTimeout; DWORD MaxVideoTimeout; DWORD MinSpindownTimeout; DWORD MaxSpindownTimeout; } ADMINISTRATOR_POWER_POLICY, *PADMINISTRATOR_POWER_POLICY; typedef enum _HIBERFILE_BUCKET_SIZE { HiberFileBucket1GB = 0, HiberFileBucket2GB, HiberFileBucket4GB, HiberFileBucket8GB, HiberFileBucket16GB, HiberFileBucket32GB, HiberFileBucketUnlimited, HiberFileBucketMax } HIBERFILE_BUCKET_SIZE, *PHIBERFILE_BUCKET_SIZE; typedef struct _HIBERFILE_BUCKET { DWORD64 MaxPhysicalMemory; DWORD PhysicalMemoryPercent[0x03]; } HIBERFILE_BUCKET, *PHIBERFILE_BUCKET; typedef struct { BOOLEAN PowerButtonPresent; BOOLEAN SleepButtonPresent; BOOLEAN LidPresent; BOOLEAN SystemS1; BOOLEAN SystemS2; BOOLEAN SystemS3; BOOLEAN SystemS4; BOOLEAN SystemS5; BOOLEAN HiberFilePresent; BOOLEAN FullWake; BOOLEAN VideoDimPresent; BOOLEAN ApmPresent; BOOLEAN UpsPresent; BOOLEAN ThermalControl; BOOLEAN ProcessorThrottle; BYTE ProcessorMinThrottle; BYTE ProcessorMaxThrottle; BOOLEAN FastSystemS4; BOOLEAN Hiberboot; BOOLEAN WakeAlarmPresent; BOOLEAN AoAc; BOOLEAN DiskSpinDown; BYTE HiberFileType; BOOLEAN AoAcConnectivitySupported; BYTE spare3[6]; BOOLEAN SystemBatteriesPresent; BOOLEAN BatteriesAreShortTerm; BATTERY_REPORTING_SCALE BatteryScale[3]; SYSTEM_POWER_STATE AcOnLineWake; SYSTEM_POWER_STATE SoftLidWake; SYSTEM_POWER_STATE RtcWake; SYSTEM_POWER_STATE MinDeviceWakeState; SYSTEM_POWER_STATE DefaultLowLatencyWake; } SYSTEM_POWER_CAPABILITIES, *PSYSTEM_POWER_CAPABILITIES; typedef struct { BOOLEAN AcOnLine; BOOLEAN BatteryPresent; BOOLEAN Charging; BOOLEAN Discharging; BOOLEAN Spare1[3]; BYTE Tag; DWORD MaxCapacity; DWORD RemainingCapacity; DWORD Rate; DWORD EstimatedTime; DWORD DefaultAlert1; DWORD DefaultAlert2; } SYSTEM_BATTERY_STATE, *PSYSTEM_BATTERY_STATE; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\pshpack4.h" #pragma warning(disable:4103) #pragma pack(push,4) #line 16217 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\pshpack2.h" #pragma warning(disable:4103) #pragma pack(push,2) #line 16225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 16235 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_DOS_HEADER { WORD e_magic; WORD e_cblp; WORD e_cp; WORD e_crlc; WORD e_cparhdr; WORD e_minalloc; WORD e_maxalloc; WORD e_ss; WORD e_sp; WORD e_csum; WORD e_ip; WORD e_cs; WORD e_lfarlc; WORD e_ovno; WORD e_res[4]; WORD e_oemid; WORD e_oeminfo; WORD e_res2[10]; LONG e_lfanew; } IMAGE_DOS_HEADER, *PIMAGE_DOS_HEADER; typedef struct _IMAGE_OS2_HEADER { WORD ne_magic; CHAR ne_ver; CHAR ne_rev; WORD ne_enttab; WORD ne_cbenttab; LONG ne_crc; WORD ne_flags; WORD ne_autodata; WORD ne_heap; WORD ne_stack; LONG ne_csip; LONG ne_sssp; WORD ne_cseg; WORD ne_cmod; WORD ne_cbnrestab; WORD ne_segtab; WORD ne_rsrctab; WORD ne_restab; WORD ne_modtab; WORD ne_imptab; LONG ne_nrestab; WORD ne_cmovent; WORD ne_align; WORD ne_cres; BYTE ne_exetyp; BYTE ne_flagsothers; WORD ne_pretthunks; WORD ne_psegrefbytes; WORD ne_swaparea; WORD ne_expver; } IMAGE_OS2_HEADER, *PIMAGE_OS2_HEADER; typedef struct _IMAGE_VXD_HEADER { WORD e32_magic; BYTE e32_border; BYTE e32_worder; DWORD e32_level; WORD e32_cpu; WORD e32_os; DWORD e32_ver; DWORD e32_mflags; DWORD e32_mpages; DWORD e32_startobj; DWORD e32_eip; DWORD e32_stackobj; DWORD e32_esp; DWORD e32_pagesize; DWORD e32_lastpagesize; DWORD e32_fixupsize; DWORD e32_fixupsum; DWORD e32_ldrsize; DWORD e32_ldrsum; DWORD e32_objtab; DWORD e32_objcnt; DWORD e32_objmap; DWORD e32_itermap; DWORD e32_rsrctab; DWORD e32_rsrccnt; DWORD e32_restab; DWORD e32_enttab; DWORD e32_dirtab; DWORD e32_dircnt; DWORD e32_fpagetab; DWORD e32_frectab; DWORD e32_impmod; DWORD e32_impmodcnt; DWORD e32_impproc; DWORD e32_pagesum; DWORD e32_datapage; DWORD e32_preload; DWORD e32_nrestab; DWORD e32_cbnrestab; DWORD e32_nressum; DWORD e32_autodata; DWORD e32_debuginfo; DWORD e32_debuglen; DWORD e32_instpreload; DWORD e32_instdemand; DWORD e32_heapsize; BYTE e32_res3[12]; DWORD e32_winresoff; DWORD e32_winreslen; WORD e32_devid; WORD e32_ddkver; } IMAGE_VXD_HEADER, *PIMAGE_VXD_HEADER; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\poppack.h" #pragma warning(disable:4103) #pragma pack(pop) #line 16347 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_FILE_HEADER { WORD Machine; WORD NumberOfSections; DWORD TimeDateStamp; DWORD PointerToSymbolTable; DWORD NumberOfSymbols; WORD SizeOfOptionalHeader; WORD Characteristics; } IMAGE_FILE_HEADER, *PIMAGE_FILE_HEADER; #line 16380 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 16413 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_DATA_DIRECTORY { DWORD VirtualAddress; DWORD Size; } IMAGE_DATA_DIRECTORY, *PIMAGE_DATA_DIRECTORY; typedef struct _IMAGE_OPTIONAL_HEADER { WORD Magic; BYTE MajorLinkerVersion; BYTE MinorLinkerVersion; DWORD SizeOfCode; DWORD SizeOfInitializedData; DWORD SizeOfUninitializedData; DWORD AddressOfEntryPoint; DWORD BaseOfCode; DWORD BaseOfData; DWORD ImageBase; DWORD SectionAlignment; DWORD FileAlignment; WORD MajorOperatingSystemVersion; WORD MinorOperatingSystemVersion; WORD MajorImageVersion; WORD MinorImageVersion; WORD MajorSubsystemVersion; WORD MinorSubsystemVersion; DWORD Win32VersionValue; DWORD SizeOfImage; DWORD SizeOfHeaders; DWORD CheckSum; WORD Subsystem; WORD DllCharacteristics; DWORD SizeOfStackReserve; DWORD SizeOfStackCommit; DWORD SizeOfHeapReserve; DWORD SizeOfHeapCommit; DWORD LoaderFlags; DWORD NumberOfRvaAndSizes; IMAGE_DATA_DIRECTORY DataDirectory[16]; } IMAGE_OPTIONAL_HEADER32, *PIMAGE_OPTIONAL_HEADER32; typedef struct _IMAGE_ROM_OPTIONAL_HEADER { WORD Magic; BYTE MajorLinkerVersion; BYTE MinorLinkerVersion; DWORD SizeOfCode; DWORD SizeOfInitializedData; DWORD SizeOfUninitializedData; DWORD AddressOfEntryPoint; DWORD BaseOfCode; DWORD BaseOfData; DWORD BaseOfBss; DWORD GprMask; DWORD CprMask[4]; DWORD GpValue; } IMAGE_ROM_OPTIONAL_HEADER, *PIMAGE_ROM_OPTIONAL_HEADER; typedef struct _IMAGE_OPTIONAL_HEADER64 { WORD Magic; BYTE MajorLinkerVersion; BYTE MinorLinkerVersion; DWORD SizeOfCode; DWORD SizeOfInitializedData; DWORD SizeOfUninitializedData; DWORD AddressOfEntryPoint; DWORD BaseOfCode; ULONGLONG ImageBase; DWORD SectionAlignment; DWORD FileAlignment; WORD MajorOperatingSystemVersion; WORD MinorOperatingSystemVersion; WORD MajorImageVersion; WORD MinorImageVersion; WORD MajorSubsystemVersion; WORD MinorSubsystemVersion; DWORD Win32VersionValue; DWORD SizeOfImage; DWORD SizeOfHeaders; DWORD CheckSum; WORD Subsystem; WORD DllCharacteristics; ULONGLONG SizeOfStackReserve; ULONGLONG SizeOfStackCommit; ULONGLONG SizeOfHeapReserve; ULONGLONG SizeOfHeapCommit; DWORD LoaderFlags; DWORD NumberOfRvaAndSizes; IMAGE_DATA_DIRECTORY DataDirectory[16]; } IMAGE_OPTIONAL_HEADER64, *PIMAGE_OPTIONAL_HEADER64; typedef IMAGE_OPTIONAL_HEADER64 IMAGE_OPTIONAL_HEADER; typedef PIMAGE_OPTIONAL_HEADER64 PIMAGE_OPTIONAL_HEADER; #line 16535 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_NT_HEADERS64 { DWORD Signature; IMAGE_FILE_HEADER FileHeader; IMAGE_OPTIONAL_HEADER64 OptionalHeader; } IMAGE_NT_HEADERS64, *PIMAGE_NT_HEADERS64; typedef struct _IMAGE_NT_HEADERS { DWORD Signature; IMAGE_FILE_HEADER FileHeader; IMAGE_OPTIONAL_HEADER32 OptionalHeader; } IMAGE_NT_HEADERS32, *PIMAGE_NT_HEADERS32; typedef struct _IMAGE_ROM_HEADERS { IMAGE_FILE_HEADER FileHeader; IMAGE_ROM_OPTIONAL_HEADER OptionalHeader; } IMAGE_ROM_HEADERS, *PIMAGE_ROM_HEADERS; typedef IMAGE_NT_HEADERS64 IMAGE_NT_HEADERS; typedef PIMAGE_NT_HEADERS64 PIMAGE_NT_HEADERS; #line 16586 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 16604 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 16614 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 16623 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct ANON_OBJECT_HEADER { WORD Sig1; WORD Sig2; WORD Version; WORD Machine; DWORD TimeDateStamp; CLSID ClassID; DWORD SizeOfData; } ANON_OBJECT_HEADER; typedef struct ANON_OBJECT_HEADER_V2 { WORD Sig1; WORD Sig2; WORD Version; WORD Machine; DWORD TimeDateStamp; CLSID ClassID; DWORD SizeOfData; DWORD Flags; DWORD MetaDataSize; DWORD MetaDataOffset; } ANON_OBJECT_HEADER_V2; typedef struct ANON_OBJECT_HEADER_BIGOBJ { WORD Sig1; WORD Sig2; WORD Version; WORD Machine; DWORD TimeDateStamp; CLSID ClassID; DWORD SizeOfData; DWORD Flags; DWORD MetaDataSize; DWORD MetaDataOffset; DWORD NumberOfSections; DWORD PointerToSymbolTable; DWORD NumberOfSymbols; } ANON_OBJECT_HEADER_BIGOBJ; typedef struct _IMAGE_SECTION_HEADER { BYTE Name[8]; union { DWORD PhysicalAddress; DWORD VirtualSize; } Misc; DWORD VirtualAddress; DWORD SizeOfRawData; DWORD PointerToRawData; DWORD PointerToRelocations; DWORD PointerToLinenumbers; WORD NumberOfRelocations; WORD NumberOfLinenumbers; DWORD Characteristics; } IMAGE_SECTION_HEADER, *PIMAGE_SECTION_HEADER; #line 16738 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 16749 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\pshpack2.h" #pragma warning(disable:4103) #pragma pack(push,2) #line 16757 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_SYMBOL { union { BYTE ShortName[8]; struct { DWORD Short; DWORD Long; } Name; DWORD LongName[2]; } N; DWORD Value; SHORT SectionNumber; WORD Type; BYTE StorageClass; BYTE NumberOfAuxSymbols; } IMAGE_SYMBOL; typedef IMAGE_SYMBOL __unaligned *PIMAGE_SYMBOL; typedef struct _IMAGE_SYMBOL_EX { union { BYTE ShortName[8]; struct { DWORD Short; DWORD Long; } Name; DWORD LongName[2]; } N; DWORD Value; LONG SectionNumber; WORD Type; BYTE StorageClass; BYTE NumberOfAuxSymbols; } IMAGE_SYMBOL_EX; typedef IMAGE_SYMBOL_EX __unaligned *PIMAGE_SYMBOL_EX; #line 16833 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 16865 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 16886 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 16918 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\pshpack2.h" #pragma warning(disable:4103) #pragma pack(push,2) #line 16920 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct IMAGE_AUX_SYMBOL_TOKEN_DEF { BYTE bAuxType; BYTE bReserved; DWORD SymbolTableIndex; BYTE rgbReserved[12]; } IMAGE_AUX_SYMBOL_TOKEN_DEF; typedef IMAGE_AUX_SYMBOL_TOKEN_DEF __unaligned *PIMAGE_AUX_SYMBOL_TOKEN_DEF; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\poppack.h" #pragma warning(disable:4103) #pragma pack(pop) #line 16931 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef union _IMAGE_AUX_SYMBOL { struct { DWORD TagIndex; union { struct { WORD Linenumber; WORD Size; } LnSz; DWORD TotalSize; } Misc; union { struct { DWORD PointerToLinenumber; DWORD PointerToNextFunction; } Function; struct { WORD Dimension[4]; } Array; } FcnAry; WORD TvIndex; } Sym; struct { BYTE Name[18]; } File; struct { DWORD Length; WORD NumberOfRelocations; WORD NumberOfLinenumbers; DWORD CheckSum; SHORT Number; BYTE Selection; BYTE bReserved; SHORT HighNumber; } Section; IMAGE_AUX_SYMBOL_TOKEN_DEF TokenDef; struct { DWORD crc; BYTE rgbReserved[14]; } CRC; } IMAGE_AUX_SYMBOL; typedef IMAGE_AUX_SYMBOL __unaligned *PIMAGE_AUX_SYMBOL; typedef union _IMAGE_AUX_SYMBOL_EX { struct { DWORD WeakDefaultSymIndex; DWORD WeakSearchType; BYTE rgbReserved[12]; } Sym; struct { BYTE Name[sizeof(IMAGE_SYMBOL_EX)]; } File; struct { DWORD Length; WORD NumberOfRelocations; WORD NumberOfLinenumbers; DWORD CheckSum; SHORT Number; BYTE Selection; BYTE bReserved; SHORT HighNumber; BYTE rgbReserved[2]; } Section; struct{ IMAGE_AUX_SYMBOL_TOKEN_DEF TokenDef; BYTE rgbReserved[2]; } ; struct { DWORD crc; BYTE rgbReserved[16]; } CRC; } IMAGE_AUX_SYMBOL_EX; typedef IMAGE_AUX_SYMBOL_EX __unaligned *PIMAGE_AUX_SYMBOL_EX; typedef enum IMAGE_AUX_SYMBOL_TYPE { IMAGE_AUX_SYMBOL_TYPE_TOKEN_DEF = 1, } IMAGE_AUX_SYMBOL_TYPE; #line 17025 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_RELOCATION { union { DWORD VirtualAddress; DWORD RelocCount; } ; DWORD SymbolTableIndex; WORD Type; } IMAGE_RELOCATION; typedef IMAGE_RELOCATION __unaligned *PIMAGE_RELOCATION; #line 17059 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17079 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17107 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17121 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17135 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17168 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17203 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17214 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17235 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17256 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17275 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17290 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17301 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17312 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17329 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_LINENUMBER { union { DWORD SymbolTableIndex; DWORD VirtualAddress; } Type; WORD Linenumber; } IMAGE_LINENUMBER; typedef IMAGE_LINENUMBER __unaligned *PIMAGE_LINENUMBER; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\poppack.h" #pragma warning(disable:4103) #pragma pack(pop) #line 17448 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_BASE_RELOCATION { DWORD VirtualAddress; DWORD SizeOfBlock; } IMAGE_BASE_RELOCATION; typedef IMAGE_BASE_RELOCATION __unaligned * PIMAGE_BASE_RELOCATION; #line 17476 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 17501 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_ARCHIVE_MEMBER_HEADER { BYTE Name[16]; BYTE Date[12]; BYTE UserID[6]; BYTE GroupID[6]; BYTE Mode[8]; BYTE Size[10]; BYTE EndHeader[2]; } IMAGE_ARCHIVE_MEMBER_HEADER, *PIMAGE_ARCHIVE_MEMBER_HEADER; typedef struct _IMAGE_EXPORT_DIRECTORY { DWORD Characteristics; DWORD TimeDateStamp; WORD MajorVersion; WORD MinorVersion; DWORD Name; DWORD Base; DWORD NumberOfFunctions; DWORD NumberOfNames; DWORD AddressOfFunctions; DWORD AddressOfNames; DWORD AddressOfNameOrdinals; } IMAGE_EXPORT_DIRECTORY, *PIMAGE_EXPORT_DIRECTORY; typedef struct _IMAGE_IMPORT_BY_NAME { WORD Hint; CHAR Name[1]; } IMAGE_IMPORT_BY_NAME, *PIMAGE_IMPORT_BY_NAME; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\pshpack8.h" #pragma warning(disable:4103) #pragma pack(push,8) #line 17547 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_THUNK_DATA64 { union { ULONGLONG ForwarderString; ULONGLONG Function; ULONGLONG Ordinal; ULONGLONG AddressOfData; } u1; } IMAGE_THUNK_DATA64; typedef IMAGE_THUNK_DATA64 * PIMAGE_THUNK_DATA64; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\poppack.h" #pragma warning(disable:4103) #pragma pack(pop) #line 17559 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_THUNK_DATA32 { union { DWORD ForwarderString; DWORD Function; DWORD Ordinal; DWORD AddressOfData; } u1; } IMAGE_THUNK_DATA32; typedef IMAGE_THUNK_DATA32 * PIMAGE_THUNK_DATA32; #line 17576 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef void (__stdcall *PIMAGE_TLS_CALLBACK) ( PVOID DllHandle, DWORD Reason, PVOID Reserved ); typedef struct _IMAGE_TLS_DIRECTORY64 { ULONGLONG StartAddressOfRawData; ULONGLONG EndAddressOfRawData; ULONGLONG AddressOfIndex; ULONGLONG AddressOfCallBacks; DWORD SizeOfZeroFill; union { DWORD Characteristics; struct { DWORD Reserved0 : 20; DWORD Alignment : 4; DWORD Reserved1 : 8; } ; } ; } IMAGE_TLS_DIRECTORY64; typedef IMAGE_TLS_DIRECTORY64 * PIMAGE_TLS_DIRECTORY64; typedef struct _IMAGE_TLS_DIRECTORY32 { DWORD StartAddressOfRawData; DWORD EndAddressOfRawData; DWORD AddressOfIndex; DWORD AddressOfCallBacks; DWORD SizeOfZeroFill; union { DWORD Characteristics; struct { DWORD Reserved0 : 20; DWORD Alignment : 4; DWORD Reserved1 : 8; } ; } ; } IMAGE_TLS_DIRECTORY32; typedef IMAGE_TLS_DIRECTORY32 * PIMAGE_TLS_DIRECTORY32; typedef IMAGE_THUNK_DATA64 IMAGE_THUNK_DATA; typedef PIMAGE_THUNK_DATA64 PIMAGE_THUNK_DATA; typedef IMAGE_TLS_DIRECTORY64 IMAGE_TLS_DIRECTORY; typedef PIMAGE_TLS_DIRECTORY64 PIMAGE_TLS_DIRECTORY; #line 17642 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_IMPORT_DESCRIPTOR { union { DWORD Characteristics; DWORD OriginalFirstThunk; } ; DWORD TimeDateStamp; DWORD ForwarderChain; DWORD Name; DWORD FirstThunk; } IMAGE_IMPORT_DESCRIPTOR; typedef IMAGE_IMPORT_DESCRIPTOR __unaligned *PIMAGE_IMPORT_DESCRIPTOR; typedef struct _IMAGE_BOUND_IMPORT_DESCRIPTOR { DWORD TimeDateStamp; WORD OffsetModuleName; WORD NumberOfModuleForwarderRefs; } IMAGE_BOUND_IMPORT_DESCRIPTOR, *PIMAGE_BOUND_IMPORT_DESCRIPTOR; typedef struct _IMAGE_BOUND_FORWARDER_REF { DWORD TimeDateStamp; WORD OffsetModuleName; WORD Reserved; } IMAGE_BOUND_FORWARDER_REF, *PIMAGE_BOUND_FORWARDER_REF; typedef struct _IMAGE_DELAYLOAD_DESCRIPTOR { union { DWORD AllAttributes; struct { DWORD RvaBased : 1; DWORD ReservedAttributes : 31; } ; } Attributes; DWORD DllNameRVA; DWORD ModuleHandleRVA; DWORD ImportAddressTableRVA; DWORD ImportNameTableRVA; DWORD BoundImportAddressTableRVA; DWORD UnloadInformationTableRVA; DWORD TimeDateStamp; } IMAGE_DELAYLOAD_DESCRIPTOR, *PIMAGE_DELAYLOAD_DESCRIPTOR; typedef const IMAGE_DELAYLOAD_DESCRIPTOR *PCIMAGE_DELAYLOAD_DESCRIPTOR; typedef struct _IMAGE_RESOURCE_DIRECTORY { DWORD Characteristics; DWORD TimeDateStamp; WORD MajorVersion; WORD MinorVersion; WORD NumberOfNamedEntries; WORD NumberOfIdEntries; } IMAGE_RESOURCE_DIRECTORY, *PIMAGE_RESOURCE_DIRECTORY; typedef struct _IMAGE_RESOURCE_DIRECTORY_ENTRY { union { struct { DWORD NameOffset:31; DWORD NameIsString:1; } ; DWORD Name; WORD Id; } ; union { DWORD OffsetToData; struct { DWORD OffsetToDirectory:31; DWORD DataIsDirectory:1; } ; } ; } IMAGE_RESOURCE_DIRECTORY_ENTRY, *PIMAGE_RESOURCE_DIRECTORY_ENTRY; typedef struct _IMAGE_RESOURCE_DIRECTORY_STRING { WORD Length; CHAR NameString[ 1 ]; } IMAGE_RESOURCE_DIRECTORY_STRING, *PIMAGE_RESOURCE_DIRECTORY_STRING; typedef struct _IMAGE_RESOURCE_DIR_STRING_U { WORD Length; WCHAR NameString[ 1 ]; } IMAGE_RESOURCE_DIR_STRING_U, *PIMAGE_RESOURCE_DIR_STRING_U; typedef struct _IMAGE_RESOURCE_DATA_ENTRY { DWORD OffsetToData; DWORD Size; DWORD CodePage; DWORD Reserved; } IMAGE_RESOURCE_DATA_ENTRY, *PIMAGE_RESOURCE_DATA_ENTRY; typedef struct _IMAGE_LOAD_CONFIG_CODE_INTEGRITY { WORD Flags; WORD Catalog; DWORD CatalogOffset; DWORD Reserved; } IMAGE_LOAD_CONFIG_CODE_INTEGRITY, *PIMAGE_LOAD_CONFIG_CODE_INTEGRITY; typedef struct _IMAGE_DYNAMIC_RELOCATION_TABLE { DWORD Version; DWORD Size; } IMAGE_DYNAMIC_RELOCATION_TABLE, *PIMAGE_DYNAMIC_RELOCATION_TABLE; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\pshpack1.h" #pragma warning(disable:4103) #pragma pack(push,1) #line 17826 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_DYNAMIC_RELOCATION32 { DWORD Symbol; DWORD BaseRelocSize; } IMAGE_DYNAMIC_RELOCATION32, *PIMAGE_DYNAMIC_RELOCATION32; typedef struct _IMAGE_DYNAMIC_RELOCATION64 { ULONGLONG Symbol; DWORD BaseRelocSize; } IMAGE_DYNAMIC_RELOCATION64, *PIMAGE_DYNAMIC_RELOCATION64; typedef struct _IMAGE_DYNAMIC_RELOCATION32_V2 { DWORD HeaderSize; DWORD FixupInfoSize; DWORD Symbol; DWORD SymbolGroup; DWORD Flags; } IMAGE_DYNAMIC_RELOCATION32_V2, *PIMAGE_DYNAMIC_RELOCATION32_V2; typedef struct _IMAGE_DYNAMIC_RELOCATION64_V2 { DWORD HeaderSize; DWORD FixupInfoSize; ULONGLONG Symbol; DWORD SymbolGroup; DWORD Flags; } IMAGE_DYNAMIC_RELOCATION64_V2, *PIMAGE_DYNAMIC_RELOCATION64_V2; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\poppack.h" #pragma warning(disable:4103) #pragma pack(pop) #line 17860 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef IMAGE_DYNAMIC_RELOCATION64 IMAGE_DYNAMIC_RELOCATION; typedef PIMAGE_DYNAMIC_RELOCATION64 PIMAGE_DYNAMIC_RELOCATION; typedef IMAGE_DYNAMIC_RELOCATION64_V2 IMAGE_DYNAMIC_RELOCATION_V2; typedef PIMAGE_DYNAMIC_RELOCATION64_V2 PIMAGE_DYNAMIC_RELOCATION_V2; #line 17872 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\pshpack1.h" #pragma warning(disable:4103) #pragma pack(push,1) #line 17881 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_PROLOGUE_DYNAMIC_RELOCATION_HEADER { BYTE PrologueByteCount; } IMAGE_PROLOGUE_DYNAMIC_RELOCATION_HEADER; typedef IMAGE_PROLOGUE_DYNAMIC_RELOCATION_HEADER __unaligned * PIMAGE_PROLOGUE_DYNAMIC_RELOCATION_HEADER; typedef struct _IMAGE_EPILOGUE_DYNAMIC_RELOCATION_HEADER { DWORD EpilogueCount; BYTE EpilogueByteCount; BYTE BranchDescriptorElementSize; WORD BranchDescriptorCount; } IMAGE_EPILOGUE_DYNAMIC_RELOCATION_HEADER; typedef IMAGE_EPILOGUE_DYNAMIC_RELOCATION_HEADER __unaligned * PIMAGE_EPILOGUE_DYNAMIC_RELOCATION_HEADER; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\poppack.h" #pragma warning(disable:4103) #pragma pack(pop) #line 17899 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_LOAD_CONFIG_DIRECTORY32 { DWORD Size; DWORD TimeDateStamp; WORD MajorVersion; WORD MinorVersion; DWORD GlobalFlagsClear; DWORD GlobalFlagsSet; DWORD CriticalSectionDefaultTimeout; DWORD DeCommitFreeBlockThreshold; DWORD DeCommitTotalFreeThreshold; DWORD LockPrefixTable; DWORD MaximumAllocationSize; DWORD VirtualMemoryThreshold; DWORD ProcessHeapFlags; DWORD ProcessAffinityMask; WORD CSDVersion; WORD DependentLoadFlags; DWORD EditList; DWORD SecurityCookie; DWORD SEHandlerTable; DWORD SEHandlerCount; DWORD GuardCFCheckFunctionPointer; DWORD GuardCFDispatchFunctionPointer; DWORD GuardCFFunctionTable; DWORD GuardCFFunctionCount; DWORD GuardFlags; IMAGE_LOAD_CONFIG_CODE_INTEGRITY CodeIntegrity; DWORD GuardAddressTakenIatEntryTable; DWORD GuardAddressTakenIatEntryCount; DWORD GuardLongJumpTargetTable; DWORD GuardLongJumpTargetCount; DWORD DynamicValueRelocTable; DWORD CHPEMetadataPointer; DWORD GuardRFFailureRoutine; DWORD GuardRFFailureRoutineFunctionPointer; DWORD DynamicValueRelocTableOffset; WORD DynamicValueRelocTableSection; WORD Reserved2; DWORD GuardRFVerifyStackPointerFunctionPointer; DWORD HotPatchTableOffset; DWORD Reserved3; DWORD EnclaveConfigurationPointer; } IMAGE_LOAD_CONFIG_DIRECTORY32, *PIMAGE_LOAD_CONFIG_DIRECTORY32; typedef struct _IMAGE_LOAD_CONFIG_DIRECTORY64 { DWORD Size; DWORD TimeDateStamp; WORD MajorVersion; WORD MinorVersion; DWORD GlobalFlagsClear; DWORD GlobalFlagsSet; DWORD CriticalSectionDefaultTimeout; ULONGLONG DeCommitFreeBlockThreshold; ULONGLONG DeCommitTotalFreeThreshold; ULONGLONG LockPrefixTable; ULONGLONG MaximumAllocationSize; ULONGLONG VirtualMemoryThreshold; ULONGLONG ProcessAffinityMask; DWORD ProcessHeapFlags; WORD CSDVersion; WORD DependentLoadFlags; ULONGLONG EditList; ULONGLONG SecurityCookie; ULONGLONG SEHandlerTable; ULONGLONG SEHandlerCount; ULONGLONG GuardCFCheckFunctionPointer; ULONGLONG GuardCFDispatchFunctionPointer; ULONGLONG GuardCFFunctionTable; ULONGLONG GuardCFFunctionCount; DWORD GuardFlags; IMAGE_LOAD_CONFIG_CODE_INTEGRITY CodeIntegrity; ULONGLONG GuardAddressTakenIatEntryTable; ULONGLONG GuardAddressTakenIatEntryCount; ULONGLONG GuardLongJumpTargetTable; ULONGLONG GuardLongJumpTargetCount; ULONGLONG DynamicValueRelocTable; ULONGLONG CHPEMetadataPointer; ULONGLONG GuardRFFailureRoutine; ULONGLONG GuardRFFailureRoutineFunctionPointer; DWORD DynamicValueRelocTableOffset; WORD DynamicValueRelocTableSection; WORD Reserved2; ULONGLONG GuardRFVerifyStackPointerFunctionPointer; DWORD HotPatchTableOffset; DWORD Reserved3; ULONGLONG EnclaveConfigurationPointer; } IMAGE_LOAD_CONFIG_DIRECTORY64, *PIMAGE_LOAD_CONFIG_DIRECTORY64; typedef IMAGE_LOAD_CONFIG_DIRECTORY64 IMAGE_LOAD_CONFIG_DIRECTORY; typedef PIMAGE_LOAD_CONFIG_DIRECTORY64 PIMAGE_LOAD_CONFIG_DIRECTORY; typedef struct _IMAGE_HOT_PATCH_INFO { DWORD Version; DWORD Size; DWORD SequenceNumber; DWORD BaseImageList; DWORD BaseImageCount; DWORD BufferOffset; } IMAGE_HOT_PATCH_INFO, *PIMAGE_HOT_PATCH_INFO; typedef struct _IMAGE_HOT_PATCH_BASE { DWORD SequenceNumber; DWORD Flags; DWORD OriginalTimeDateStamp; DWORD OriginalCheckSum; DWORD CodeIntegrityInfo; DWORD CodeIntegritySize; DWORD PatchTable; DWORD BufferOffset; } IMAGE_HOT_PATCH_BASE, *PIMAGE_HOT_PATCH_BASE; typedef struct _IMAGE_HOT_PATCH_HASHES { BYTE SHA256[32]; BYTE SHA1[20]; } IMAGE_HOT_PATCH_HASHES, *PIMAGE_HOT_PATCH_HASHES; #line 18039 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 18048 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 18056 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 18064 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_CE_RUNTIME_FUNCTION_ENTRY { DWORD FuncStart; DWORD PrologLen : 8; DWORD FuncLen : 22; DWORD ThirtyTwoBit : 1; DWORD ExceptionFlag : 1; } IMAGE_CE_RUNTIME_FUNCTION_ENTRY, * PIMAGE_CE_RUNTIME_FUNCTION_ENTRY; typedef struct _IMAGE_ARM_RUNTIME_FUNCTION_ENTRY { DWORD BeginAddress; union { DWORD UnwindData; struct { DWORD Flag : 2; DWORD FunctionLength : 11; DWORD Ret : 2; DWORD H : 1; DWORD Reg : 3; DWORD R : 1; DWORD L : 1; DWORD C : 1; DWORD StackAdjust : 10; } ; } ; } IMAGE_ARM_RUNTIME_FUNCTION_ENTRY, * PIMAGE_ARM_RUNTIME_FUNCTION_ENTRY; typedef struct _IMAGE_ARM64_RUNTIME_FUNCTION_ENTRY { DWORD BeginAddress; union { DWORD UnwindData; struct { DWORD Flag : 2; DWORD FunctionLength : 11; DWORD RegF : 3; DWORD RegI : 4; DWORD H : 1; DWORD CR : 2; DWORD FrameSize : 9; } ; } ; } IMAGE_ARM64_RUNTIME_FUNCTION_ENTRY, * PIMAGE_ARM64_RUNTIME_FUNCTION_ENTRY; typedef struct _IMAGE_ALPHA64_RUNTIME_FUNCTION_ENTRY { ULONGLONG BeginAddress; ULONGLONG EndAddress; ULONGLONG ExceptionHandler; ULONGLONG HandlerData; ULONGLONG PrologEndAddress; } IMAGE_ALPHA64_RUNTIME_FUNCTION_ENTRY, *PIMAGE_ALPHA64_RUNTIME_FUNCTION_ENTRY; typedef struct _IMAGE_ALPHA_RUNTIME_FUNCTION_ENTRY { DWORD BeginAddress; DWORD EndAddress; DWORD ExceptionHandler; DWORD HandlerData; DWORD PrologEndAddress; } IMAGE_ALPHA_RUNTIME_FUNCTION_ENTRY, *PIMAGE_ALPHA_RUNTIME_FUNCTION_ENTRY; typedef struct _IMAGE_RUNTIME_FUNCTION_ENTRY { DWORD BeginAddress; DWORD EndAddress; union { DWORD UnwindInfoAddress; DWORD UnwindData; } ; } _IMAGE_RUNTIME_FUNCTION_ENTRY, *_PIMAGE_RUNTIME_FUNCTION_ENTRY; typedef _IMAGE_RUNTIME_FUNCTION_ENTRY IMAGE_IA64_RUNTIME_FUNCTION_ENTRY; typedef _PIMAGE_RUNTIME_FUNCTION_ENTRY PIMAGE_IA64_RUNTIME_FUNCTION_ENTRY; #line 18174 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef _IMAGE_RUNTIME_FUNCTION_ENTRY IMAGE_RUNTIME_FUNCTION_ENTRY; typedef _PIMAGE_RUNTIME_FUNCTION_ENTRY PIMAGE_RUNTIME_FUNCTION_ENTRY; typedef struct _IMAGE_ENCLAVE_CONFIG32 { DWORD Size; DWORD MinimumRequiredConfigSize; DWORD PolicyFlags; DWORD NumberOfImports; DWORD ImportList; DWORD ImportEntrySize; BYTE FamilyID[16]; BYTE ImageID[16]; DWORD ImageVersion; DWORD SecurityVersion; DWORD EnclaveSize; DWORD NumberOfThreads; DWORD EnclaveFlags; } IMAGE_ENCLAVE_CONFIG32, *PIMAGE_ENCLAVE_CONFIG32; typedef struct _IMAGE_ENCLAVE_CONFIG64 { DWORD Size; DWORD MinimumRequiredConfigSize; DWORD PolicyFlags; DWORD NumberOfImports; DWORD ImportList; DWORD ImportEntrySize; BYTE FamilyID[16]; BYTE ImageID[16]; DWORD ImageVersion; DWORD SecurityVersion; ULONGLONG EnclaveSize; DWORD NumberOfThreads; DWORD EnclaveFlags; } IMAGE_ENCLAVE_CONFIG64, *PIMAGE_ENCLAVE_CONFIG64; typedef IMAGE_ENCLAVE_CONFIG64 IMAGE_ENCLAVE_CONFIG; typedef PIMAGE_ENCLAVE_CONFIG64 PIMAGE_ENCLAVE_CONFIG; typedef struct _IMAGE_ENCLAVE_IMPORT { DWORD MatchType; DWORD MinimumSecurityVersion; BYTE UniqueOrAuthorID[32]; BYTE FamilyID[16]; BYTE ImageID[16]; DWORD ImportName; DWORD Reserved; } IMAGE_ENCLAVE_IMPORT, *PIMAGE_ENCLAVE_IMPORT; typedef struct _IMAGE_DEBUG_DIRECTORY { DWORD Characteristics; DWORD TimeDateStamp; WORD MajorVersion; WORD MinorVersion; DWORD Type; DWORD SizeOfData; DWORD AddressOfRawData; DWORD PointerToRawData; } IMAGE_DEBUG_DIRECTORY, *PIMAGE_DEBUG_DIRECTORY; #line 18281 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _IMAGE_COFF_SYMBOLS_HEADER { DWORD NumberOfSymbols; DWORD LvaToFirstSymbol; DWORD NumberOfLinenumbers; DWORD LvaToFirstLinenumber; DWORD RvaToFirstByteOfCode; DWORD RvaToLastByteOfCode; DWORD RvaToFirstByteOfData; DWORD RvaToLastByteOfData; } IMAGE_COFF_SYMBOLS_HEADER, *PIMAGE_COFF_SYMBOLS_HEADER; typedef struct _FPO_DATA { DWORD ulOffStart; DWORD cbProcSize; DWORD cdwLocals; WORD cdwParams; WORD cbProlog : 8; WORD cbRegs : 3; WORD fHasSEH : 1; WORD fUseBP : 1; WORD reserved : 1; WORD cbFrame : 2; } FPO_DATA, *PFPO_DATA; typedef struct _IMAGE_DEBUG_MISC { DWORD DataType; DWORD Length; BOOLEAN Unicode; BYTE Reserved[ 3 ]; BYTE Data[ 1 ]; } IMAGE_DEBUG_MISC, *PIMAGE_DEBUG_MISC; typedef struct _IMAGE_FUNCTION_ENTRY { DWORD StartingAddress; DWORD EndingAddress; DWORD EndOfPrologue; } IMAGE_FUNCTION_ENTRY, *PIMAGE_FUNCTION_ENTRY; typedef struct _IMAGE_FUNCTION_ENTRY64 { ULONGLONG StartingAddress; ULONGLONG EndingAddress; union { ULONGLONG EndOfPrologue; ULONGLONG UnwindInfoAddress; } ; } IMAGE_FUNCTION_ENTRY64, *PIMAGE_FUNCTION_ENTRY64; typedef struct _IMAGE_SEPARATE_DEBUG_HEADER { WORD Signature; WORD Flags; WORD Machine; WORD Characteristics; DWORD TimeDateStamp; DWORD CheckSum; DWORD ImageBase; DWORD SizeOfImage; DWORD NumberOfSections; DWORD ExportedNamesSize; DWORD DebugDirectorySize; DWORD SectionAlignment; DWORD Reserved[2]; } IMAGE_SEPARATE_DEBUG_HEADER, *PIMAGE_SEPARATE_DEBUG_HEADER; typedef struct _NON_PAGED_DEBUG_INFO { WORD Signature; WORD Flags; DWORD Size; WORD Machine; WORD Characteristics; DWORD TimeDateStamp; DWORD CheckSum; DWORD SizeOfImage; ULONGLONG ImageBase; } NON_PAGED_DEBUG_INFO, *PNON_PAGED_DEBUG_INFO; #line 18408 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _ImageArchitectureHeader { unsigned int AmaskValue: 1; int :7; unsigned int AmaskShift: 8; int :16; DWORD FirstEntryRVA; } IMAGE_ARCHITECTURE_HEADER, *PIMAGE_ARCHITECTURE_HEADER; typedef struct _ImageArchitectureEntry { DWORD FixupInstRVA; DWORD NewInst; } IMAGE_ARCHITECTURE_ENTRY, *PIMAGE_ARCHITECTURE_ENTRY; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\poppack.h" #pragma warning(disable:4103) #pragma pack(pop) #line 18436 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct IMPORT_OBJECT_HEADER { WORD Sig1; WORD Sig2; WORD Version; WORD Machine; DWORD TimeDateStamp; DWORD SizeOfData; union { WORD Ordinal; WORD Hint; } ; WORD Type : 2; WORD NameType : 3; WORD Reserved : 11; } IMPORT_OBJECT_HEADER; typedef enum IMPORT_OBJECT_TYPE { IMPORT_OBJECT_CODE = 0, IMPORT_OBJECT_DATA = 1, IMPORT_OBJECT_CONST = 2, } IMPORT_OBJECT_TYPE; typedef enum IMPORT_OBJECT_NAME_TYPE { IMPORT_OBJECT_ORDINAL = 0, IMPORT_OBJECT_NAME = 1, IMPORT_OBJECT_NAME_NO_PREFIX = 2, IMPORT_OBJECT_NAME_UNDECORATE = 3, IMPORT_OBJECT_NAME_EXPORTAS = 4, } IMPORT_OBJECT_NAME_TYPE; typedef enum ReplacesCorHdrNumericDefines { COMIMAGE_FLAGS_ILONLY =0x00000001, COMIMAGE_FLAGS_32BITREQUIRED =0x00000002, COMIMAGE_FLAGS_IL_LIBRARY =0x00000004, COMIMAGE_FLAGS_STRONGNAMESIGNED =0x00000008, COMIMAGE_FLAGS_NATIVE_ENTRYPOINT =0x00000010, COMIMAGE_FLAGS_TRACKDEBUGDATA =0x00010000, COMIMAGE_FLAGS_32BITPREFERRED =0x00020000, COR_VERSION_MAJOR_V2 =2, COR_VERSION_MAJOR =COR_VERSION_MAJOR_V2, COR_VERSION_MINOR =5, COR_DELETED_NAME_LENGTH =8, COR_VTABLEGAP_NAME_LENGTH =8, NATIVE_TYPE_MAX_CB =1, COR_ILMETHOD_SECT_SMALL_MAX_DATASIZE=0xFF, IMAGE_COR_MIH_METHODRVA =0x01, IMAGE_COR_MIH_EHRVA =0x02, IMAGE_COR_MIH_BASICBLOCK =0x08, COR_VTABLE_32BIT =0x01, COR_VTABLE_64BIT =0x02, COR_VTABLE_FROM_UNMANAGED =0x04, COR_VTABLE_FROM_UNMANAGED_RETAIN_APPDOMAIN =0x08, COR_VTABLE_CALL_MOST_DERIVED =0x10, IMAGE_COR_EATJ_THUNK_SIZE =32, MAX_CLASS_NAME =1024, MAX_PACKAGE_NAME =1024, } ReplacesCorHdrNumericDefines; typedef struct IMAGE_COR20_HEADER { DWORD cb; WORD MajorRuntimeVersion; WORD MinorRuntimeVersion; IMAGE_DATA_DIRECTORY MetaData; DWORD Flags; union { DWORD EntryPointToken; DWORD EntryPointRVA; } ; IMAGE_DATA_DIRECTORY Resources; IMAGE_DATA_DIRECTORY StrongNameSignature; IMAGE_DATA_DIRECTORY CodeManagerTable; IMAGE_DATA_DIRECTORY VTableFixups; IMAGE_DATA_DIRECTORY ExportAddressTableJumps; IMAGE_DATA_DIRECTORY ManagedNativeHeader; } IMAGE_COR20_HEADER, *PIMAGE_COR20_HEADER; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apiset.h" #line 83 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apiset.h" #line 94 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apiset.h" #line 103 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apiset.h" #line 125 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apiset.h" #line 18566 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #pragma region Application or OneCore Family __declspec(dllimport) WORD __stdcall RtlCaptureStackBackTrace( DWORD FramesToSkip, DWORD FramesToCapture, PVOID* BackTrace, PDWORD BackTraceHash ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) void __stdcall RtlCaptureContext( PCONTEXT ContextRecord ); #pragma endregion #pragma region Application or OneCore Family __declspec(dllimport) void __stdcall RtlUnwind( PVOID TargetFrame, PVOID TargetIp, PEXCEPTION_RECORD ExceptionRecord, PVOID ReturnValue ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOLEAN __cdecl RtlAddFunctionTable( PRUNTIME_FUNCTION FunctionTable, DWORD EntryCount, DWORD64 BaseAddress ); __declspec(dllimport) BOOLEAN __cdecl RtlDeleteFunctionTable( PRUNTIME_FUNCTION FunctionTable ); __declspec(dllimport) BOOLEAN __cdecl RtlInstallFunctionTableCallback( DWORD64 TableIdentifier, DWORD64 BaseAddress, DWORD Length, PGET_RUNTIME_FUNCTION_CALLBACK Callback, PVOID Context, PCWSTR OutOfProcessCallbackDll ); __declspec(dllimport) DWORD __stdcall RtlAddGrowableFunctionTable( PVOID* DynamicTable, PRUNTIME_FUNCTION FunctionTable, DWORD EntryCount, DWORD MaximumEntryCount, ULONG_PTR RangeBase, ULONG_PTR RangeEnd ); __declspec(dllimport) void __stdcall RtlGrowFunctionTable( PVOID DynamicTable, DWORD NewEntryCount ); __declspec(dllimport) void __stdcall RtlDeleteGrowableFunctionTable( PVOID DynamicTable ); #pragma endregion #pragma region Application or OneCore Family __declspec(dllimport) PRUNTIME_FUNCTION __stdcall RtlLookupFunctionEntry( DWORD64 ControlPc, PDWORD64 ImageBase, PUNWIND_HISTORY_TABLE HistoryTable ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) void __cdecl RtlRestoreContext( PCONTEXT ContextRecord, struct _EXCEPTION_RECORD* ExceptionRecord ); #pragma endregion #pragma region Application or OneCore Family __declspec(dllimport) void __stdcall RtlUnwindEx( PVOID TargetFrame, PVOID TargetIp, PEXCEPTION_RECORD ExceptionRecord, PVOID ReturnValue, PCONTEXT ContextRecord, PUNWIND_HISTORY_TABLE HistoryTable ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) PEXCEPTION_ROUTINE __stdcall RtlVirtualUnwind( DWORD HandlerType, DWORD64 ImageBase, DWORD64 ControlPc, PRUNTIME_FUNCTION FunctionEntry, PCONTEXT ContextRecord, PVOID* HandlerData, PDWORD64 EstablisherFrame, PKNONVOLATILE_CONTEXT_POINTERS ContextPointers ); #pragma endregion #line 18922 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 19068 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 19107 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #pragma region Application or OneCore Family __declspec(dllimport) PVOID __stdcall RtlPcToFileHeader( PVOID PcValue, PVOID* BaseOfImage ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) SIZE_T __stdcall RtlCompareMemory( const void* Source1, const void* Source2, SIZE_T Length ); #pragma endregion #line 19156 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #pragma warning(push) #pragma warning(disable:4324) typedef struct __declspec(align(16)) _SLIST_ENTRY { struct _SLIST_ENTRY *Next; } SLIST_ENTRY, *PSLIST_ENTRY; #pragma warning(pop) typedef union __declspec(align(16)) _SLIST_HEADER { struct { ULONGLONG Alignment; ULONGLONG Region; } ; struct { ULONGLONG Depth:16; ULONGLONG Sequence:48; ULONGLONG Reserved:4; ULONGLONG NextEntry:60; } HeaderX64; } SLIST_HEADER, *PSLIST_HEADER; #line 19241 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #pragma region Desktop Family or OneCore Family __declspec(dllimport) void __stdcall RtlInitializeSListHead ( PSLIST_HEADER ListHead ); __declspec(dllimport) PSLIST_ENTRY __stdcall RtlFirstEntrySList ( const SLIST_HEADER *ListHead ); __declspec(dllimport) PSLIST_ENTRY __stdcall RtlInterlockedPopEntrySList ( PSLIST_HEADER ListHead ); __declspec(dllimport) PSLIST_ENTRY __stdcall RtlInterlockedPushEntrySList ( PSLIST_HEADER ListHead, PSLIST_ENTRY ListEntry ); __declspec(dllimport) PSLIST_ENTRY __stdcall RtlInterlockedPushListSListEx ( PSLIST_HEADER ListHead, PSLIST_ENTRY List, PSLIST_ENTRY ListEnd, DWORD Count ); __declspec(dllimport) PSLIST_ENTRY __stdcall RtlInterlockedFlushSList ( PSLIST_HEADER ListHead ); __declspec(dllimport) WORD __stdcall RtlQueryDepthSList ( PSLIST_HEADER ListHead ); #pragma endregion typedef union _RTL_RUN_ONCE { PVOID Ptr; } RTL_RUN_ONCE, *PRTL_RUN_ONCE; typedef struct _RTL_BARRIER { DWORD Reserved1; DWORD Reserved2; ULONG_PTR Reserved3[2]; DWORD Reserved4; DWORD Reserved5; } RTL_BARRIER, *PRTL_BARRIER; #line 19414 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" __declspec(noreturn) void __fastfail( unsigned int Code ); #pragma intrinsic(__fastfail) #line 19443 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #pragma region Desktop Family __forceinline DWORD HEAP_MAKE_TAG_FLAGS ( DWORD TagBase, DWORD Tag ) { return ((DWORD)((TagBase) + ((Tag) << 18))); } #pragma endregion #line 19490 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 19514 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" __forceinline PVOID RtlSecureZeroMemory( PVOID ptr, SIZE_T cnt ) { volatile char *vptr = (volatile char *)ptr; __stosb((PBYTE )((DWORD64)vptr), 0, cnt); #line 19557 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" return ptr; } #line 19578 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _MESSAGE_RESOURCE_ENTRY { WORD Length; WORD Flags; BYTE Text[ 1 ]; } MESSAGE_RESOURCE_ENTRY, *PMESSAGE_RESOURCE_ENTRY; typedef struct _MESSAGE_RESOURCE_BLOCK { DWORD LowId; DWORD HighId; DWORD OffsetToEntries; } MESSAGE_RESOURCE_BLOCK, *PMESSAGE_RESOURCE_BLOCK; typedef struct _MESSAGE_RESOURCE_DATA { DWORD NumberOfBlocks; MESSAGE_RESOURCE_BLOCK Blocks[ 1 ]; } MESSAGE_RESOURCE_DATA, *PMESSAGE_RESOURCE_DATA; typedef struct _OSVERSIONINFOA { DWORD dwOSVersionInfoSize; DWORD dwMajorVersion; DWORD dwMinorVersion; DWORD dwBuildNumber; DWORD dwPlatformId; CHAR szCSDVersion[ 128 ]; } OSVERSIONINFOA, *POSVERSIONINFOA, *LPOSVERSIONINFOA; typedef struct _OSVERSIONINFOW { DWORD dwOSVersionInfoSize; DWORD dwMajorVersion; DWORD dwMinorVersion; DWORD dwBuildNumber; DWORD dwPlatformId; WCHAR szCSDVersion[ 128 ]; } OSVERSIONINFOW, *POSVERSIONINFOW, *LPOSVERSIONINFOW, RTL_OSVERSIONINFOW, *PRTL_OSVERSIONINFOW; typedef OSVERSIONINFOA OSVERSIONINFO; typedef POSVERSIONINFOA POSVERSIONINFO; typedef LPOSVERSIONINFOA LPOSVERSIONINFO; typedef struct _OSVERSIONINFOEXA { DWORD dwOSVersionInfoSize; DWORD dwMajorVersion; DWORD dwMinorVersion; DWORD dwBuildNumber; DWORD dwPlatformId; CHAR szCSDVersion[ 128 ]; WORD wServicePackMajor; WORD wServicePackMinor; WORD wSuiteMask; BYTE wProductType; BYTE wReserved; } OSVERSIONINFOEXA, *POSVERSIONINFOEXA, *LPOSVERSIONINFOEXA; typedef struct _OSVERSIONINFOEXW { DWORD dwOSVersionInfoSize; DWORD dwMajorVersion; DWORD dwMinorVersion; DWORD dwBuildNumber; DWORD dwPlatformId; WCHAR szCSDVersion[ 128 ]; WORD wServicePackMajor; WORD wServicePackMinor; WORD wSuiteMask; BYTE wProductType; BYTE wReserved; } OSVERSIONINFOEXW, *POSVERSIONINFOEXW, *LPOSVERSIONINFOEXW, RTL_OSVERSIONINFOEXW, *PRTL_OSVERSIONINFOEXW; typedef OSVERSIONINFOEXA OSVERSIONINFOEX; typedef POSVERSIONINFOEXA POSVERSIONINFOEX; typedef LPOSVERSIONINFOEXA LPOSVERSIONINFOEX; #line 19680 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 19696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #pragma region Desktop Family or OneCore Family __declspec(dllimport) ULONGLONG __stdcall VerSetConditionMask( ULONGLONG ConditionMask, DWORD TypeMask, BYTE Condition ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOLEAN __stdcall RtlGetProductInfo( DWORD OSMajorVersion, DWORD OSMinorVersion, DWORD SpMajorVersion, DWORD SpMinorVersion, PDWORD ReturnedProductType ); #pragma endregion typedef enum _RTL_UMS_THREAD_INFO_CLASS { UmsThreadInvalidInfoClass = 0, UmsThreadUserContext, UmsThreadPriority, UmsThreadAffinity, UmsThreadTeb, UmsThreadIsSuspended, UmsThreadIsTerminated, UmsThreadMaxInfoClass } RTL_UMS_THREAD_INFO_CLASS, *PRTL_UMS_THREAD_INFO_CLASS; typedef enum _RTL_UMS_SCHEDULER_REASON { UmsSchedulerStartup = 0, UmsSchedulerThreadBlocked, UmsSchedulerThreadYield, } RTL_UMS_SCHEDULER_REASON, *PRTL_UMS_SCHEDULER_REASON; typedef void __stdcall RTL_UMS_SCHEDULER_ENTRY_POINT( RTL_UMS_SCHEDULER_REASON Reason, ULONG_PTR ActivationPayload, PVOID SchedulerParam ); typedef RTL_UMS_SCHEDULER_ENTRY_POINT *PRTL_UMS_SCHEDULER_ENTRY_POINT; #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall RtlCrc32( const void *Buffer, size_t Size, DWORD InitialCrc ); __declspec(dllimport) ULONGLONG __stdcall RtlCrc64( const void *Buffer, size_t Size, ULONGLONG InitialCrc ); #pragma endregion typedef enum _OS_DEPLOYEMENT_STATE_VALUES { OS_DEPLOYMENT_STANDARD = 1, OS_DEPLOYMENT_COMPACT } OS_DEPLOYEMENT_STATE_VALUES; __declspec(dllimport) OS_DEPLOYEMENT_STATE_VALUES __stdcall RtlOsDeploymentState( DWORD Flags ); typedef struct _NV_MEMORY_RANGE { void *BaseAddress; SIZE_T Length; } NV_MEMORY_RANGE, *PNV_MEMORY_RANGE; __declspec(dllimport) DWORD __stdcall RtlGetNonVolatileToken ( PVOID NvBuffer, SIZE_T Size, PVOID *NvToken ); __declspec(dllimport) DWORD __stdcall RtlFreeNonVolatileToken ( PVOID NvToken ); __declspec(dllimport) DWORD __stdcall RtlFlushNonVolatileMemory ( PVOID NvToken, PVOID NvBuffer, SIZE_T Size, DWORD Flags ); __declspec(dllimport) DWORD __stdcall RtlDrainNonVolatileFlush ( PVOID NvToken ); __declspec(dllimport) DWORD __stdcall RtlWriteNonVolatileMemory ( PVOID NvToken, void __unaligned *NvDestination, void __unaligned *Source, SIZE_T Size, DWORD Flags ); __declspec(dllimport) DWORD __stdcall RtlFlushNonVolatileMemoryRanges ( PVOID NvToken, PNV_MEMORY_RANGE NvRanges, SIZE_T NumRanges, DWORD Flags ); typedef struct CORRELATION_VECTOR { CHAR Version; CHAR Vector[129]; } CORRELATION_VECTOR; typedef CORRELATION_VECTOR *PCORRELATION_VECTOR; __declspec(dllimport) DWORD __stdcall RtlInitializeCorrelationVector( PCORRELATION_VECTOR CorrelationVector, int Version, const GUID * Guid ); __declspec(dllimport) DWORD __stdcall RtlIncrementCorrelationVector( PCORRELATION_VECTOR CorrelationVector ); __declspec(dllimport) DWORD __stdcall RtlExtendCorrelationVector( PCORRELATION_VECTOR CorrelationVector ); __declspec(dllimport) DWORD __stdcall RtlValidateCorrelationVector( PCORRELATION_VECTOR Vector ); typedef struct _CUSTOM_SYSTEM_EVENT_TRIGGER_CONFIG { DWORD Size; PCWSTR TriggerId; } CUSTOM_SYSTEM_EVENT_TRIGGER_CONFIG, *PCUSTOM_SYSTEM_EVENT_TRIGGER_CONFIG; __forceinline void CUSTOM_SYSTEM_EVENT_TRIGGER_INIT( PCUSTOM_SYSTEM_EVENT_TRIGGER_CONFIG Config, PCWSTR TriggerId ) { memset((Config),0,(sizeof(CUSTOM_SYSTEM_EVENT_TRIGGER_CONFIG))); Config->Size = sizeof(CUSTOM_SYSTEM_EVENT_TRIGGER_CONFIG); Config->TriggerId = TriggerId; } DWORD __stdcall RtlRaiseCustomSystemEventTrigger( PCUSTOM_SYSTEM_EVENT_TRIGGER_CONFIG TriggerConfig ); typedef enum _IMAGE_POLICY_ENTRY_TYPE { ImagePolicyEntryTypeNone = 0, ImagePolicyEntryTypeBool, ImagePolicyEntryTypeInt8, ImagePolicyEntryTypeUInt8, ImagePolicyEntryTypeInt16, ImagePolicyEntryTypeUInt16, ImagePolicyEntryTypeInt32, ImagePolicyEntryTypeUInt32, ImagePolicyEntryTypeInt64, ImagePolicyEntryTypeUInt64, ImagePolicyEntryTypeAnsiString, ImagePolicyEntryTypeUnicodeString, ImagePolicyEntryTypeOverride, ImagePolicyEntryTypeMaximum } IMAGE_POLICY_ENTRY_TYPE; typedef enum _IMAGE_POLICY_ID { ImagePolicyIdNone = 0, ImagePolicyIdEtw, ImagePolicyIdDebug, ImagePolicyIdCrashDump, ImagePolicyIdCrashDumpKey, ImagePolicyIdCrashDumpKeyGuid, ImagePolicyIdParentSd, ImagePolicyIdParentSdRev, ImagePolicyIdSvn, ImagePolicyIdDeviceId, ImagePolicyIdCapability, ImagePolicyIdScenarioId, ImagePolicyIdMaximum } IMAGE_POLICY_ID; typedef struct _IMAGE_POLICY_ENTRY { IMAGE_POLICY_ENTRY_TYPE Type; IMAGE_POLICY_ID PolicyId; union { const void* None; BOOLEAN BoolValue; INT8 Int8Value; UINT8 UInt8Value; INT16 Int16Value; UINT16 UInt16Value; INT32 Int32Value; UINT32 UInt32Value; INT64 Int64Value; UINT64 UInt64Value; PCSTR AnsiStringValue; PCWSTR UnicodeStringValue; } u; } IMAGE_POLICY_ENTRY; typedef const IMAGE_POLICY_ENTRY* PCIMAGE_POLICY_ENTRY; #pragma warning(push) #pragma warning(disable:4200) typedef struct _IMAGE_POLICY_METADATA { BYTE Version; BYTE Reserved0[7]; ULONGLONG ApplicationId; IMAGE_POLICY_ENTRY Policies[]; } IMAGE_POLICY_METADATA; typedef const IMAGE_POLICY_METADATA* PCIMAGE_POLICY_METADATA; #pragma warning(pop) #line 20189 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _RTL_CRITICAL_SECTION_DEBUG { WORD Type; WORD CreatorBackTraceIndex; struct _RTL_CRITICAL_SECTION *CriticalSection; LIST_ENTRY ProcessLocksList; DWORD EntryCount; DWORD ContentionCount; DWORD Flags; WORD CreatorBackTraceIndexHigh; WORD SpareWORD ; } RTL_CRITICAL_SECTION_DEBUG, *PRTL_CRITICAL_SECTION_DEBUG, RTL_RESOURCE_DEBUG, *PRTL_RESOURCE_DEBUG; #line 20255 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #pragma pack(push, 8) typedef struct _RTL_CRITICAL_SECTION { PRTL_CRITICAL_SECTION_DEBUG DebugInfo; LONG LockCount; LONG RecursionCount; HANDLE OwningThread; HANDLE LockSemaphore; ULONG_PTR SpinCount; } RTL_CRITICAL_SECTION, *PRTL_CRITICAL_SECTION; #pragma pack(pop) typedef struct _RTL_SRWLOCK { PVOID Ptr; } RTL_SRWLOCK, *PRTL_SRWLOCK; typedef struct _RTL_CONDITION_VARIABLE { PVOID Ptr; } RTL_CONDITION_VARIABLE, *PRTL_CONDITION_VARIABLE; typedef void (__stdcall *PAPCFUNC)( ULONG_PTR Parameter ); typedef LONG (__stdcall *PVECTORED_EXCEPTION_HANDLER)( struct _EXCEPTION_POINTERS *ExceptionInfo ); typedef enum _HEAP_INFORMATION_CLASS { HeapCompatibilityInformation = 0, HeapEnableTerminationOnCorruption = 1 , HeapOptimizeResources = 3 } HEAP_INFORMATION_CLASS; typedef struct _HEAP_OPTIMIZE_RESOURCES_INFORMATION { DWORD Version; DWORD Flags; } HEAP_OPTIMIZE_RESOURCES_INFORMATION, *PHEAP_OPTIMIZE_RESOURCES_INFORMATION; #line 20339 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef void (__stdcall * WAITORTIMERCALLBACKFUNC) (PVOID, BOOLEAN ); typedef void (__stdcall * WORKERCALLBACKFUNC) (PVOID ); typedef void (__stdcall * APC_CALLBACK_FUNCTION) (DWORD , PVOID, PVOID); typedef WAITORTIMERCALLBACKFUNC WAITORTIMERCALLBACK; typedef void (__stdcall *PFLS_CALLBACK_FUNCTION) ( PVOID lpFlsData ); typedef BOOLEAN (__stdcall *PSECURE_MEMORY_CACHE_CALLBACK) ( PVOID Addr, SIZE_T Range ); typedef enum _ACTIVATION_CONTEXT_INFO_CLASS { ActivationContextBasicInformation = 1, ActivationContextDetailedInformation = 2, AssemblyDetailedInformationInActivationContext = 3, FileInformationInAssemblyOfAssemblyInActivationContext = 4, RunlevelInformationInActivationContext = 5, CompatibilityInformationInActivationContext = 6, ActivationContextManifestResourceName = 7, MaxActivationContextInfoClass, AssemblyDetailedInformationInActivationContxt = 3, FileInformationInAssemblyOfAssemblyInActivationContxt = 4 } ACTIVATION_CONTEXT_INFO_CLASS; typedef struct _ACTIVATION_CONTEXT_QUERY_INDEX { DWORD ulAssemblyIndex; DWORD ulFileIndexInAssembly; } ACTIVATION_CONTEXT_QUERY_INDEX, * PACTIVATION_CONTEXT_QUERY_INDEX; typedef const struct _ACTIVATION_CONTEXT_QUERY_INDEX * PCACTIVATION_CONTEXT_QUERY_INDEX; typedef struct _ASSEMBLY_FILE_DETAILED_INFORMATION { DWORD ulFlags; DWORD ulFilenameLength; DWORD ulPathLength; PCWSTR lpFileName; PCWSTR lpFilePath; } ASSEMBLY_FILE_DETAILED_INFORMATION, *PASSEMBLY_FILE_DETAILED_INFORMATION; typedef const ASSEMBLY_FILE_DETAILED_INFORMATION *PCASSEMBLY_FILE_DETAILED_INFORMATION; typedef struct _ACTIVATION_CONTEXT_ASSEMBLY_DETAILED_INFORMATION { DWORD ulFlags; DWORD ulEncodedAssemblyIdentityLength; DWORD ulManifestPathType; DWORD ulManifestPathLength; LARGE_INTEGER liManifestLastWriteTime; DWORD ulPolicyPathType; DWORD ulPolicyPathLength; LARGE_INTEGER liPolicyLastWriteTime; DWORD ulMetadataSatelliteRosterIndex; DWORD ulManifestVersionMajor; DWORD ulManifestVersionMinor; DWORD ulPolicyVersionMajor; DWORD ulPolicyVersionMinor; DWORD ulAssemblyDirectoryNameLength; PCWSTR lpAssemblyEncodedAssemblyIdentity; PCWSTR lpAssemblyManifestPath; PCWSTR lpAssemblyPolicyPath; PCWSTR lpAssemblyDirectoryName; DWORD ulFileCount; } ACTIVATION_CONTEXT_ASSEMBLY_DETAILED_INFORMATION, * PACTIVATION_CONTEXT_ASSEMBLY_DETAILED_INFORMATION; typedef const struct _ACTIVATION_CONTEXT_ASSEMBLY_DETAILED_INFORMATION * PCACTIVATION_CONTEXT_ASSEMBLY_DETAILED_INFORMATION ; typedef enum { ACTCTX_RUN_LEVEL_UNSPECIFIED = 0, ACTCTX_RUN_LEVEL_AS_INVOKER, ACTCTX_RUN_LEVEL_HIGHEST_AVAILABLE, ACTCTX_RUN_LEVEL_REQUIRE_ADMIN, ACTCTX_RUN_LEVEL_NUMBERS } ACTCTX_REQUESTED_RUN_LEVEL; typedef struct _ACTIVATION_CONTEXT_RUN_LEVEL_INFORMATION { DWORD ulFlags; ACTCTX_REQUESTED_RUN_LEVEL RunLevel; DWORD UiAccess; } ACTIVATION_CONTEXT_RUN_LEVEL_INFORMATION, * PACTIVATION_CONTEXT_RUN_LEVEL_INFORMATION; typedef const struct _ACTIVATION_CONTEXT_RUN_LEVEL_INFORMATION * PCACTIVATION_CONTEXT_RUN_LEVEL_INFORMATION ; typedef enum { ACTCTX_COMPATIBILITY_ELEMENT_TYPE_UNKNOWN = 0, ACTCTX_COMPATIBILITY_ELEMENT_TYPE_OS, ACTCTX_COMPATIBILITY_ELEMENT_TYPE_MITIGATION } ACTCTX_COMPATIBILITY_ELEMENT_TYPE; typedef struct _COMPATIBILITY_CONTEXT_ELEMENT { GUID Id; ACTCTX_COMPATIBILITY_ELEMENT_TYPE Type; } COMPATIBILITY_CONTEXT_ELEMENT, *PCOMPATIBILITY_CONTEXT_ELEMENT; typedef const struct _COMPATIBILITY_CONTEXT_ELEMENT *PCCOMPATIBILITY_CONTEXT_ELEMENT; #pragma warning(push) #pragma warning(disable:4200) typedef struct _ACTIVATION_CONTEXT_COMPATIBILITY_INFORMATION { DWORD ElementCount; COMPATIBILITY_CONTEXT_ELEMENT Elements[]; } ACTIVATION_CONTEXT_COMPATIBILITY_INFORMATION, * PACTIVATION_CONTEXT_COMPATIBILITY_INFORMATION; #pragma warning(pop) typedef const struct _ACTIVATION_CONTEXT_COMPATIBILITY_INFORMATION * PCACTIVATION_CONTEXT_COMPATIBILITY_INFORMATION; typedef struct _SUPPORTED_OS_INFO { WORD MajorVersion; WORD MinorVersion; } SUPPORTED_OS_INFO, *PSUPPORTED_OS_INFO; typedef struct _ACTIVATION_CONTEXT_DETAILED_INFORMATION { DWORD dwFlags; DWORD ulFormatVersion; DWORD ulAssemblyCount; DWORD ulRootManifestPathType; DWORD ulRootManifestPathChars; DWORD ulRootConfigurationPathType; DWORD ulRootConfigurationPathChars; DWORD ulAppDirPathType; DWORD ulAppDirPathChars; PCWSTR lpRootManifestPath; PCWSTR lpRootConfigurationPath; PCWSTR lpAppDirPath; } ACTIVATION_CONTEXT_DETAILED_INFORMATION, *PACTIVATION_CONTEXT_DETAILED_INFORMATION; typedef const struct _ACTIVATION_CONTEXT_DETAILED_INFORMATION *PCACTIVATION_CONTEXT_DETAILED_INFORMATION; typedef struct _HARDWARE_COUNTER_DATA { HARDWARE_COUNTER_TYPE Type; DWORD Reserved; DWORD64 Value; } HARDWARE_COUNTER_DATA, *PHARDWARE_COUNTER_DATA; typedef struct _PERFORMANCE_DATA { WORD Size; BYTE Version; BYTE HwCountersCount; DWORD ContextSwitchCount; DWORD64 WaitReasonBitMap; DWORD64 CycleTime; DWORD RetryCount; DWORD Reserved; HARDWARE_COUNTER_DATA HwCounters[16]; } PERFORMANCE_DATA, *PPERFORMANCE_DATA; #pragma region Desktop Family #line 20565 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 20602 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" void __stdcall RtlGetDeviceFamilyInfoEnum( ULONGLONG *pullUAPInfo, DWORD *pulDeviceFamily, DWORD *pulDeviceForm ); DWORD __stdcall RtlConvertDeviceFamilyInfoToString( PDWORD pulDeviceFamilyBufferSize, PDWORD pulDeviceFormBufferSize, PWSTR DeviceFamily, PWSTR DeviceForm ); DWORD __stdcall RtlSwitchedVVI( PRTL_OSVERSIONINFOEXW VersionInfo, DWORD TypeMask, ULONGLONG ConditionMask ); #pragma endregion #line 20659 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _EVENTLOGRECORD { DWORD Length; DWORD Reserved; DWORD RecordNumber; DWORD TimeGenerated; DWORD TimeWritten; DWORD EventID; WORD EventType; WORD NumStrings; WORD EventCategory; WORD ReservedFlags; DWORD ClosingRecordNumber; DWORD StringOffset; DWORD UserSidLength; DWORD UserSidOffset; DWORD DataLength; DWORD DataOffset; } EVENTLOGRECORD, *PEVENTLOGRECORD; #pragma warning(push) #pragma warning(disable : 4200) struct _EVENTSFORLOGFILE; typedef struct _EVENTSFORLOGFILE EVENTSFORLOGFILE, *PEVENTSFORLOGFILE; struct _PACKEDEVENTINFO; typedef struct _PACKEDEVENTINFO PACKEDEVENTINFO, *PPACKEDEVENTINFO; struct _EVENTSFORLOGFILE { DWORD ulSize; WCHAR szLogicalLogFile[256]; DWORD ulNumRecords; EVENTLOGRECORD pEventLogRecords[]; }; struct _PACKEDEVENTINFO { DWORD ulSize; DWORD ulNumEventsForLogFile; DWORD ulOffsets[]; }; #pragma warning(pop) #line 20768 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 20775 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 20796 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 20833 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 20874 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 20898 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 20921 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 20960 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef enum _CM_SERVICE_NODE_TYPE { DriverType = 0x00000001, FileSystemType = 0x00000002, Win32ServiceOwnProcess = 0x00000010, Win32ServiceShareProcess = 0x00000020, AdapterType = 0x00000004, RecognizerType = 0x00000008 } SERVICE_NODE_TYPE; typedef enum _CM_SERVICE_LOAD_TYPE { BootLoad = 0x00000000, SystemLoad = 0x00000001, AutoLoad = 0x00000002, DemandLoad = 0x00000003, DisableLoad = 0x00000004 } SERVICE_LOAD_TYPE; typedef enum _CM_ERROR_CONTROL_TYPE { IgnoreError = 0x00000000, NormalError = 0x00000001, SevereError = 0x00000002, CriticalError = 0x00000003 } SERVICE_ERROR_TYPE; #line 21047 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 21060 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _TAPE_ERASE { DWORD Type; BOOLEAN Immediate; } TAPE_ERASE, *PTAPE_ERASE; #line 21087 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _TAPE_PREPARE { DWORD Operation; BOOLEAN Immediate; } TAPE_PREPARE, *PTAPE_PREPARE; typedef struct _TAPE_WRITE_MARKS { DWORD Type; DWORD Count; BOOLEAN Immediate; } TAPE_WRITE_MARKS, *PTAPE_WRITE_MARKS; typedef struct _TAPE_GET_POSITION { DWORD Type; DWORD Partition; LARGE_INTEGER Offset; } TAPE_GET_POSITION, *PTAPE_GET_POSITION; #line 21136 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef struct _TAPE_SET_POSITION { DWORD Method; DWORD Partition; LARGE_INTEGER Offset; BOOLEAN Immediate; } TAPE_SET_POSITION, *PTAPE_SET_POSITION; typedef struct _TAPE_GET_DRIVE_PARAMETERS { BOOLEAN ECC; BOOLEAN Compression; BOOLEAN DataPadding; BOOLEAN ReportSetmarks; DWORD DefaultBlockSize; DWORD MaximumBlockSize; DWORD MinimumBlockSize; DWORD MaximumPartitionCount; DWORD FeaturesLow; DWORD FeaturesHigh; DWORD EOTWarningZoneSize; } TAPE_GET_DRIVE_PARAMETERS, *PTAPE_GET_DRIVE_PARAMETERS; typedef struct _TAPE_SET_DRIVE_PARAMETERS { BOOLEAN ECC; BOOLEAN Compression; BOOLEAN DataPadding; BOOLEAN ReportSetmarks; DWORD EOTWarningZoneSize; } TAPE_SET_DRIVE_PARAMETERS, *PTAPE_SET_DRIVE_PARAMETERS; typedef struct _TAPE_GET_MEDIA_PARAMETERS { LARGE_INTEGER Capacity; LARGE_INTEGER Remaining; DWORD BlockSize; DWORD PartitionCount; BOOLEAN WriteProtected; } TAPE_GET_MEDIA_PARAMETERS, *PTAPE_GET_MEDIA_PARAMETERS; typedef struct _TAPE_SET_MEDIA_PARAMETERS { DWORD BlockSize; } TAPE_SET_MEDIA_PARAMETERS, *PTAPE_SET_MEDIA_PARAMETERS; typedef struct _TAPE_CREATE_PARTITION { DWORD Method; DWORD Count; DWORD Size; } TAPE_CREATE_PARTITION, *PTAPE_CREATE_PARTITION; typedef struct _TAPE_WMI_OPERATIONS { DWORD Method; DWORD DataBufferSize; PVOID DataBuffer; } TAPE_WMI_OPERATIONS, *PTAPE_WMI_OPERATIONS; typedef enum _TAPE_DRIVE_PROBLEM_TYPE { TapeDriveProblemNone, TapeDriveReadWriteWarning, TapeDriveReadWriteError, TapeDriveReadWarning, TapeDriveWriteWarning, TapeDriveReadError, TapeDriveWriteError, TapeDriveHardwareError, TapeDriveUnsupportedMedia, TapeDriveScsiConnectionError, TapeDriveTimetoClean, TapeDriveCleanDriveNow, TapeDriveMediaLifeExpired, TapeDriveSnappedTape } TAPE_DRIVE_PROBLEM_TYPE; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\ktmtypes.h" #pragma warning(push) #pragma warning(disable:4820) typedef GUID UOW, *PUOW; typedef GUID CRM_PROTOCOL_ID, *PCRM_PROTOCOL_ID; #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\ktmtypes.h" typedef ULONG NOTIFICATION_MASK; #line 109 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\ktmtypes.h" typedef struct _TRANSACTION_NOTIFICATION { PVOID TransactionKey; ULONG TransactionNotification; LARGE_INTEGER TmVirtualClock; ULONG ArgumentLength; } TRANSACTION_NOTIFICATION, *PTRANSACTION_NOTIFICATION; typedef struct _TRANSACTION_NOTIFICATION_RECOVERY_ARGUMENT { GUID EnlistmentId; UOW UOW; } TRANSACTION_NOTIFICATION_RECOVERY_ARGUMENT, *PTRANSACTION_NOTIFICATION_RECOVERY_ARGUMENT; typedef struct _TRANSACTION_NOTIFICATION_TM_ONLINE_ARGUMENT { GUID TmIdentity; ULONG Flags; } TRANSACTION_NOTIFICATION_TM_ONLINE_ARGUMENT, *PTRANSACTION_NOTIFICATION_TM_ONLINE_ARGUMENT; typedef ULONG SAVEPOINT_ID, *PSAVEPOINT_ID; typedef struct _TRANSACTION_NOTIFICATION_SAVEPOINT_ARGUMENT { SAVEPOINT_ID SavepointId; } TRANSACTION_NOTIFICATION_SAVEPOINT_ARGUMENT, *PTRANSACTION_NOTIFICATION_SAVEPOINT_ARGUMENT; typedef struct _TRANSACTION_NOTIFICATION_PROPAGATE_ARGUMENT { ULONG PropagationCookie; GUID UOW; GUID TmIdentity; ULONG BufferLength; } TRANSACTION_NOTIFICATION_PROPAGATE_ARGUMENT, *PTRANSACTION_NOTIFICATION_PROPAGATE_ARGUMENT; typedef struct _TRANSACTION_NOTIFICATION_MARSHAL_ARGUMENT { ULONG MarshalCookie; GUID UOW; } TRANSACTION_NOTIFICATION_MARSHAL_ARGUMENT, *PTRANSACTION_NOTIFICATION_MARSHAL_ARGUMENT; typedef TRANSACTION_NOTIFICATION_PROPAGATE_ARGUMENT TRANSACTION_NOTIFICATION_PROMOTE_ARGUMENT, *PTRANSACTION_NOTIFICATION_PROMOTE_ARGUMENT; typedef struct _KCRM_MARSHAL_HEADER { ULONG VersionMajor; ULONG VersionMinor; ULONG NumProtocols; ULONG Unused; } KCRM_MARSHAL_HEADER, *PKCRM_MARSHAL_HEADER, * PRKCRM_MARSHAL_HEADER; typedef struct _KCRM_TRANSACTION_BLOB { UOW UOW; GUID TmIdentity; ULONG IsolationLevel; ULONG IsolationFlags; ULONG Timeout; WCHAR Description[64]; } KCRM_TRANSACTION_BLOB, *PKCRM_TRANSACTION_BLOB, * PRKCRM_TRANSACTION_BLOB; typedef struct _KCRM_PROTOCOL_BLOB { CRM_PROTOCOL_ID ProtocolId; ULONG StaticInfoLength; ULONG TransactionIdInfoLength; ULONG Unused1; ULONG Unused2; } KCRM_PROTOCOL_BLOB, *PKCRM_PROTOCOL_BLOB, * PRKCRM_PROTOCOL_BLOB; #pragma warning(pop) #line 21330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #pragma warning(push) #pragma warning(disable:4820) #line 21387 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 21407 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 21425 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 21436 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 21452 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 21459 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" typedef enum _TRANSACTION_OUTCOME { TransactionOutcomeUndetermined = 1, TransactionOutcomeCommitted, TransactionOutcomeAborted, } TRANSACTION_OUTCOME; typedef enum _TRANSACTION_STATE { TransactionStateNormal = 1, TransactionStateIndoubt, TransactionStateCommittedNotify, } TRANSACTION_STATE; typedef struct _TRANSACTION_BASIC_INFORMATION { GUID TransactionId; DWORD State; DWORD Outcome; } TRANSACTION_BASIC_INFORMATION, *PTRANSACTION_BASIC_INFORMATION; typedef struct _TRANSACTIONMANAGER_BASIC_INFORMATION { GUID TmIdentity; LARGE_INTEGER VirtualClock; } TRANSACTIONMANAGER_BASIC_INFORMATION, *PTRANSACTIONMANAGER_BASIC_INFORMATION; typedef struct _TRANSACTIONMANAGER_LOG_INFORMATION { GUID LogIdentity; } TRANSACTIONMANAGER_LOG_INFORMATION, *PTRANSACTIONMANAGER_LOG_INFORMATION; typedef struct _TRANSACTIONMANAGER_LOGPATH_INFORMATION { DWORD LogPathLength; WCHAR LogPath[1]; } TRANSACTIONMANAGER_LOGPATH_INFORMATION, *PTRANSACTIONMANAGER_LOGPATH_INFORMATION; typedef struct _TRANSACTIONMANAGER_RECOVERY_INFORMATION { ULONGLONG LastRecoveredLsn; } TRANSACTIONMANAGER_RECOVERY_INFORMATION, *PTRANSACTIONMANAGER_RECOVERY_INFORMATION; typedef struct _TRANSACTIONMANAGER_OLDEST_INFORMATION { GUID OldestTransactionGuid; } TRANSACTIONMANAGER_OLDEST_INFORMATION, *PTRANSACTIONMANAGER_OLDEST_INFORMATION; typedef struct _TRANSACTION_PROPERTIES_INFORMATION { DWORD IsolationLevel; DWORD IsolationFlags; LARGE_INTEGER Timeout; DWORD Outcome; DWORD DescriptionLength; WCHAR Description[1]; } TRANSACTION_PROPERTIES_INFORMATION, *PTRANSACTION_PROPERTIES_INFORMATION; typedef struct _TRANSACTION_BIND_INFORMATION { HANDLE TmHandle; } TRANSACTION_BIND_INFORMATION, *PTRANSACTION_BIND_INFORMATION; typedef struct _TRANSACTION_ENLISTMENT_PAIR { GUID EnlistmentId; GUID ResourceManagerId; } TRANSACTION_ENLISTMENT_PAIR, *PTRANSACTION_ENLISTMENT_PAIR; typedef struct _TRANSACTION_ENLISTMENTS_INFORMATION { DWORD NumberOfEnlistments; TRANSACTION_ENLISTMENT_PAIR EnlistmentPair[1]; } TRANSACTION_ENLISTMENTS_INFORMATION, *PTRANSACTION_ENLISTMENTS_INFORMATION; typedef struct _TRANSACTION_SUPERIOR_ENLISTMENT_INFORMATION { TRANSACTION_ENLISTMENT_PAIR SuperiorEnlistmentPair; } TRANSACTION_SUPERIOR_ENLISTMENT_INFORMATION, *PTRANSACTION_SUPERIOR_ENLISTMENT_INFORMATION; typedef struct _RESOURCEMANAGER_BASIC_INFORMATION { GUID ResourceManagerId; DWORD DescriptionLength; WCHAR Description[1]; } RESOURCEMANAGER_BASIC_INFORMATION, *PRESOURCEMANAGER_BASIC_INFORMATION; typedef struct _RESOURCEMANAGER_COMPLETION_INFORMATION { HANDLE IoCompletionPortHandle; ULONG_PTR CompletionKey; } RESOURCEMANAGER_COMPLETION_INFORMATION, *PRESOURCEMANAGER_COMPLETION_INFORMATION; typedef enum _TRANSACTION_INFORMATION_CLASS { TransactionBasicInformation, TransactionPropertiesInformation, TransactionEnlistmentInformation, TransactionSuperiorEnlistmentInformation , TransactionBindInformation, TransactionDTCPrivateInformation , } TRANSACTION_INFORMATION_CLASS; typedef enum _TRANSACTIONMANAGER_INFORMATION_CLASS { TransactionManagerBasicInformation, TransactionManagerLogInformation, TransactionManagerLogPathInformation, TransactionManagerRecoveryInformation = 4 , TransactionManagerOnlineProbeInformation = 3, TransactionManagerOldestTransactionInformation = 5 } TRANSACTIONMANAGER_INFORMATION_CLASS; typedef enum _RESOURCEMANAGER_INFORMATION_CLASS { ResourceManagerBasicInformation, ResourceManagerCompletionInformation, } RESOURCEMANAGER_INFORMATION_CLASS; typedef struct _ENLISTMENT_BASIC_INFORMATION { GUID EnlistmentId; GUID TransactionId; GUID ResourceManagerId; } ENLISTMENT_BASIC_INFORMATION, *PENLISTMENT_BASIC_INFORMATION; typedef struct _ENLISTMENT_CRM_INFORMATION { GUID CrmTransactionManagerId; GUID CrmResourceManagerId; GUID CrmEnlistmentId; } ENLISTMENT_CRM_INFORMATION, *PENLISTMENT_CRM_INFORMATION; typedef enum _ENLISTMENT_INFORMATION_CLASS { EnlistmentBasicInformation, EnlistmentRecoveryInformation, EnlistmentCrmInformation } ENLISTMENT_INFORMATION_CLASS; typedef struct _TRANSACTION_LIST_ENTRY { UOW UOW; } TRANSACTION_LIST_ENTRY, *PTRANSACTION_LIST_ENTRY; typedef struct _TRANSACTION_LIST_INFORMATION { DWORD NumberOfTransactions; TRANSACTION_LIST_ENTRY TransactionInformation[1]; } TRANSACTION_LIST_INFORMATION, *PTRANSACTION_LIST_INFORMATION; typedef enum _KTMOBJECT_TYPE { KTMOBJECT_TRANSACTION, KTMOBJECT_TRANSACTION_MANAGER, KTMOBJECT_RESOURCE_MANAGER, KTMOBJECT_ENLISTMENT, KTMOBJECT_INVALID } KTMOBJECT_TYPE, *PKTMOBJECT_TYPE; typedef struct _KTMOBJECT_CURSOR { GUID LastQuery; DWORD ObjectIdCount; GUID ObjectIds[1]; } KTMOBJECT_CURSOR, *PKTMOBJECT_CURSOR; #pragma warning(pop) typedef DWORD TP_VERSION, *PTP_VERSION; typedef struct _TP_CALLBACK_INSTANCE TP_CALLBACK_INSTANCE, *PTP_CALLBACK_INSTANCE; typedef void (__stdcall *PTP_SIMPLE_CALLBACK)( PTP_CALLBACK_INSTANCE Instance, PVOID Context ); typedef struct _TP_POOL TP_POOL, *PTP_POOL; typedef enum _TP_CALLBACK_PRIORITY { TP_CALLBACK_PRIORITY_HIGH, TP_CALLBACK_PRIORITY_NORMAL, TP_CALLBACK_PRIORITY_LOW, TP_CALLBACK_PRIORITY_INVALID, TP_CALLBACK_PRIORITY_COUNT = TP_CALLBACK_PRIORITY_INVALID } TP_CALLBACK_PRIORITY; typedef struct _TP_POOL_STACK_INFORMATION { SIZE_T StackReserve; SIZE_T StackCommit; }TP_POOL_STACK_INFORMATION, *PTP_POOL_STACK_INFORMATION; typedef struct _TP_CLEANUP_GROUP TP_CLEANUP_GROUP, *PTP_CLEANUP_GROUP; typedef void (__stdcall *PTP_CLEANUP_GROUP_CANCEL_CALLBACK)( PVOID ObjectContext, PVOID CleanupContext ); typedef struct _TP_CALLBACK_ENVIRON_V3 { TP_VERSION Version; PTP_POOL Pool; PTP_CLEANUP_GROUP CleanupGroup; PTP_CLEANUP_GROUP_CANCEL_CALLBACK CleanupGroupCancelCallback; PVOID RaceDll; struct _ACTIVATION_CONTEXT *ActivationContext; PTP_SIMPLE_CALLBACK FinalizationCallback; union { DWORD Flags; struct { DWORD LongFunction : 1; DWORD Persistent : 1; DWORD Private : 30; } s; } u; TP_CALLBACK_PRIORITY CallbackPriority; DWORD Size; } TP_CALLBACK_ENVIRON_V3; typedef TP_CALLBACK_ENVIRON_V3 TP_CALLBACK_ENVIRON, *PTP_CALLBACK_ENVIRON; #line 21807 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" __forceinline void TpInitializeCallbackEnviron( PTP_CALLBACK_ENVIRON CallbackEnviron ) { CallbackEnviron->Version = 3; CallbackEnviron->Pool = ((void *)0); CallbackEnviron->CleanupGroup = ((void *)0); CallbackEnviron->CleanupGroupCancelCallback = ((void *)0); CallbackEnviron->RaceDll = ((void *)0); CallbackEnviron->ActivationContext = ((void *)0); CallbackEnviron->FinalizationCallback = ((void *)0); CallbackEnviron->u.Flags = 0; CallbackEnviron->CallbackPriority = TP_CALLBACK_PRIORITY_NORMAL; CallbackEnviron->Size = sizeof(TP_CALLBACK_ENVIRON); } __forceinline void TpSetCallbackThreadpool( PTP_CALLBACK_ENVIRON CallbackEnviron, PTP_POOL Pool ) { CallbackEnviron->Pool = Pool; } __forceinline void TpSetCallbackCleanupGroup( PTP_CALLBACK_ENVIRON CallbackEnviron, PTP_CLEANUP_GROUP CleanupGroup, PTP_CLEANUP_GROUP_CANCEL_CALLBACK CleanupGroupCancelCallback ) { CallbackEnviron->CleanupGroup = CleanupGroup; CallbackEnviron->CleanupGroupCancelCallback = CleanupGroupCancelCallback; } __forceinline void TpSetCallbackActivationContext( PTP_CALLBACK_ENVIRON CallbackEnviron, struct _ACTIVATION_CONTEXT *ActivationContext ) { CallbackEnviron->ActivationContext = ActivationContext; } __forceinline void TpSetCallbackNoActivationContext( PTP_CALLBACK_ENVIRON CallbackEnviron ) { CallbackEnviron->ActivationContext = (struct _ACTIVATION_CONTEXT *)(LONG_PTR) -1; } __forceinline void TpSetCallbackLongFunction( PTP_CALLBACK_ENVIRON CallbackEnviron ) { CallbackEnviron->u.s.LongFunction = 1; } __forceinline void TpSetCallbackRaceWithDll( PTP_CALLBACK_ENVIRON CallbackEnviron, PVOID DllHandle ) { CallbackEnviron->RaceDll = DllHandle; } __forceinline void TpSetCallbackFinalizationCallback( PTP_CALLBACK_ENVIRON CallbackEnviron, PTP_SIMPLE_CALLBACK FinalizationCallback ) { CallbackEnviron->FinalizationCallback = FinalizationCallback; } __forceinline void TpSetCallbackPriority( PTP_CALLBACK_ENVIRON CallbackEnviron, TP_CALLBACK_PRIORITY Priority ) { CallbackEnviron->CallbackPriority = Priority; } __forceinline void TpSetCallbackPersistent( PTP_CALLBACK_ENVIRON CallbackEnviron ) { CallbackEnviron->u.s.Persistent = 1; } __forceinline void TpDestroyCallbackEnviron( PTP_CALLBACK_ENVIRON CallbackEnviron ) { (CallbackEnviron); } typedef struct _TP_WORK TP_WORK, *PTP_WORK; typedef void (__stdcall *PTP_WORK_CALLBACK)( PTP_CALLBACK_INSTANCE Instance, PVOID Context, PTP_WORK Work ); typedef struct _TP_TIMER TP_TIMER, *PTP_TIMER; typedef void (__stdcall *PTP_TIMER_CALLBACK)( PTP_CALLBACK_INSTANCE Instance, PVOID Context, PTP_TIMER Timer ); typedef DWORD TP_WAIT_RESULT; typedef struct _TP_WAIT TP_WAIT, *PTP_WAIT; typedef void (__stdcall *PTP_WAIT_CALLBACK)( PTP_CALLBACK_INSTANCE Instance, PVOID Context, PTP_WAIT Wait, TP_WAIT_RESULT WaitResult ); typedef struct _TP_IO TP_IO, *PTP_IO; __forceinline struct _TEB * NtCurrentTeb ( void ) { return (struct _TEB *)__readgsqword(((LONG)(LONG_PTR)&(((NT_TIB *)0)->Self))); } __forceinline PVOID GetCurrentFiber ( void ) { return (PVOID)__readgsqword(((LONG)(LONG_PTR)&(((NT_TIB *)0)->FiberData))); } __forceinline PVOID GetFiberData ( void ) { return *(PVOID *)GetCurrentFiber(); } #line 22053 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 22086 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 22099 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #line 22113 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winnt.h" #pragma warning(pop) #line 183 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\minwindef.h" typedef UINT_PTR WPARAM; typedef LONG_PTR LPARAM; typedef LONG_PTR LRESULT; #line 208 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\minwindef.h" typedef HANDLE *SPHANDLE; typedef HANDLE *LPHANDLE; typedef HANDLE HGLOBAL; typedef HANDLE HLOCAL; typedef HANDLE GLOBALHANDLE; typedef HANDLE LOCALHANDLE; #pragma warning(push) #pragma warning(disable:4255) typedef INT_PTR ( __stdcall *FARPROC)(); typedef INT_PTR ( __stdcall *NEARPROC)(); typedef INT_PTR (__stdcall *PROC)(); #line 237 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\minwindef.h" #pragma warning(pop) #line 244 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\minwindef.h" typedef WORD ATOM; struct HKEY__{int unused;}; typedef struct HKEY__ *HKEY; typedef HKEY *PHKEY; struct HMETAFILE__{int unused;}; typedef struct HMETAFILE__ *HMETAFILE; struct HINSTANCE__{int unused;}; typedef struct HINSTANCE__ *HINSTANCE; typedef HINSTANCE HMODULE; struct HRGN__{int unused;}; typedef struct HRGN__ *HRGN; struct HRSRC__{int unused;}; typedef struct HRSRC__ *HRSRC; struct HSPRITE__{int unused;}; typedef struct HSPRITE__ *HSPRITE; struct HLSURF__{int unused;}; typedef struct HLSURF__ *HLSURF; struct HSTR__{int unused;}; typedef struct HSTR__ *HSTR; struct HTASK__{int unused;}; typedef struct HTASK__ *HTASK; struct HWINSTA__{int unused;}; typedef struct HWINSTA__ *HWINSTA; struct HKL__{int unused;}; typedef struct HKL__ *HKL; typedef int HFILE; typedef struct _FILETIME { DWORD dwLowDateTime; DWORD dwHighDateTime; } FILETIME, *PFILETIME, *LPFILETIME; #pragma endregion #line 25 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\windef.h" #pragma region Application Family or OneCore Family struct HWND__{int unused;}; typedef struct HWND__ *HWND; struct HHOOK__{int unused;}; typedef struct HHOOK__ *HHOOK; #pragma endregion #line 57 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\windef.h" #pragma region Application Family typedef void * HGDIOBJ; struct HACCEL__{int unused;}; typedef struct HACCEL__ *HACCEL; struct HBITMAP__{int unused;}; typedef struct HBITMAP__ *HBITMAP; struct HBRUSH__{int unused;}; typedef struct HBRUSH__ *HBRUSH; struct HCOLORSPACE__{int unused;}; typedef struct HCOLORSPACE__ *HCOLORSPACE; struct HDC__{int unused;}; typedef struct HDC__ *HDC; struct HGLRC__{int unused;}; typedef struct HGLRC__ *HGLRC; struct HDESK__{int unused;}; typedef struct HDESK__ *HDESK; struct HENHMETAFILE__{int unused;}; typedef struct HENHMETAFILE__ *HENHMETAFILE; struct HFONT__{int unused;}; typedef struct HFONT__ *HFONT; struct HICON__{int unused;}; typedef struct HICON__ *HICON; struct HMENU__{int unused;}; typedef struct HMENU__ *HMENU; struct HPALETTE__{int unused;}; typedef struct HPALETTE__ *HPALETTE; struct HPEN__{int unused;}; typedef struct HPEN__ *HPEN; struct HWINEVENTHOOK__{int unused;}; typedef struct HWINEVENTHOOK__ *HWINEVENTHOOK; #pragma endregion #pragma region Application Family struct HMONITOR__{int unused;}; typedef struct HMONITOR__ *HMONITOR; #pragma endregion #pragma region Desktop Family struct HUMPD__{int unused;}; typedef struct HUMPD__ *HUMPD; #pragma endregion #pragma region Application Family typedef HICON HCURSOR; typedef DWORD COLORREF; #pragma endregion #pragma region Desktop Family typedef DWORD *LPCOLORREF; #pragma endregion #pragma region Application Family typedef struct tagRECT { LONG left; LONG top; LONG right; LONG bottom; } RECT, *PRECT, *NPRECT, *LPRECT; typedef const RECT * LPCRECT; typedef struct _RECTL { LONG left; LONG top; LONG right; LONG bottom; } RECTL, *PRECTL, *LPRECTL; typedef const RECTL * LPCRECTL; typedef struct tagPOINT { LONG x; LONG y; } POINT, *PPOINT, *NPPOINT, *LPPOINT; typedef struct _POINTL { LONG x; LONG y; } POINTL, *PPOINTL; typedef struct tagSIZE { LONG cx; LONG cy; } SIZE, *PSIZE, *LPSIZE; typedef SIZE SIZEL; typedef SIZE *PSIZEL, *LPSIZEL; typedef struct tagPOINTS { SHORT x; SHORT y; } POINTS, *PPOINTS, *LPPOINTS; #pragma endregion #line 239 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\windef.h" #pragma region Desktop Family struct DPI_AWARENESS_CONTEXT__{int unused;}; typedef struct DPI_AWARENESS_CONTEXT__ *DPI_AWARENESS_CONTEXT; typedef enum DPI_AWARENESS { DPI_AWARENESS_INVALID = -1, DPI_AWARENESS_UNAWARE = 0, DPI_AWARENESS_SYSTEM_AWARE = 1, DPI_AWARENESS_PER_MONITOR_AWARE = 2 } DPI_AWARENESS; typedef enum DPI_HOSTING_BEHAVIOR { DPI_HOSTING_BEHAVIOR_INVALID = -1, DPI_HOSTING_BEHAVIOR_DEFAULT = 0, DPI_HOSTING_BEHAVIOR_MIXED = 1 } DPI_HOSTING_BEHAVIOR; #line 172 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\windows.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma once #pragma warning(push) #pragma warning(disable:4820) #pragma warning(disable:4668) #pragma warning(disable:4001) #pragma warning(disable:4201) #pragma warning(disable:4214) #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 19 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 27 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 35 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 45 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 53 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 61 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 69 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 77 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 85 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 93 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\apisetcconv.h" #line 35 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\minwinbase.h" #pragma once #pragma warning(disable:4514) #pragma warning(disable:4103) #pragma warning(push) #pragma warning(disable:4820) #pragma warning(disable:4001) #pragma warning(disable:4201) #pragma warning(disable:4214) typedef struct _SECURITY_ATTRIBUTES { DWORD nLength; LPVOID lpSecurityDescriptor; BOOL bInheritHandle; } SECURITY_ATTRIBUTES, *PSECURITY_ATTRIBUTES, *LPSECURITY_ATTRIBUTES; typedef struct _OVERLAPPED { ULONG_PTR Internal; ULONG_PTR InternalHigh; union { struct { DWORD Offset; DWORD OffsetHigh; } ; PVOID Pointer; } ; HANDLE hEvent; } OVERLAPPED, *LPOVERLAPPED; typedef struct _OVERLAPPED_ENTRY { ULONG_PTR lpCompletionKey; LPOVERLAPPED lpOverlapped; ULONG_PTR Internal; DWORD dwNumberOfBytesTransferred; } OVERLAPPED_ENTRY, *LPOVERLAPPED_ENTRY; #line 85 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\minwinbase.h" typedef struct _SYSTEMTIME { WORD wYear; WORD wMonth; WORD wDayOfWeek; WORD wDay; WORD wHour; WORD wMinute; WORD wSecond; WORD wMilliseconds; } SYSTEMTIME, *PSYSTEMTIME, *LPSYSTEMTIME; typedef struct _WIN32_FIND_DATAA { DWORD dwFileAttributes; FILETIME ftCreationTime; FILETIME ftLastAccessTime; FILETIME ftLastWriteTime; DWORD nFileSizeHigh; DWORD nFileSizeLow; DWORD dwReserved0; DWORD dwReserved1; CHAR cFileName[ 260 ]; CHAR cAlternateFileName[ 14 ]; } WIN32_FIND_DATAA, *PWIN32_FIND_DATAA, *LPWIN32_FIND_DATAA; typedef struct _WIN32_FIND_DATAW { DWORD dwFileAttributes; FILETIME ftCreationTime; FILETIME ftLastAccessTime; FILETIME ftLastWriteTime; DWORD nFileSizeHigh; DWORD nFileSizeLow; DWORD dwReserved0; DWORD dwReserved1; WCHAR cFileName[ 260 ]; WCHAR cAlternateFileName[ 14 ]; } WIN32_FIND_DATAW, *PWIN32_FIND_DATAW, *LPWIN32_FIND_DATAW; typedef WIN32_FIND_DATAA WIN32_FIND_DATA; typedef PWIN32_FIND_DATAA PWIN32_FIND_DATA; typedef LPWIN32_FIND_DATAA LPWIN32_FIND_DATA; typedef enum _FINDEX_INFO_LEVELS { FindExInfoStandard, FindExInfoBasic, FindExInfoMaxInfoLevel } FINDEX_INFO_LEVELS; typedef enum _FINDEX_SEARCH_OPS { FindExSearchNameMatch, FindExSearchLimitToDirectories, FindExSearchLimitToDevices, FindExSearchMaxSearchOp } FINDEX_SEARCH_OPS; typedef enum _READ_DIRECTORY_NOTIFY_INFORMATION_CLASS { ReadDirectoryNotifyInformation = 1, ReadDirectoryNotifyExtendedInformation } READ_DIRECTORY_NOTIFY_INFORMATION_CLASS, *PREAD_DIRECTORY_NOTIFY_INFORMATION_CLASS; typedef enum _GET_FILEEX_INFO_LEVELS { GetFileExInfoStandard, GetFileExMaxInfoLevel } GET_FILEEX_INFO_LEVELS; typedef enum _FILE_INFO_BY_HANDLE_CLASS { FileBasicInfo, FileStandardInfo, FileNameInfo, FileRenameInfo, FileDispositionInfo, FileAllocationInfo, FileEndOfFileInfo, FileStreamInfo, FileCompressionInfo, FileAttributeTagInfo, FileIdBothDirectoryInfo, FileIdBothDirectoryRestartInfo, FileIoPriorityHintInfo, FileRemoteProtocolInfo, FileFullDirectoryInfo, FileFullDirectoryRestartInfo, FileStorageInfo, FileAlignmentInfo, FileIdInfo, FileIdExtdDirectoryInfo, FileIdExtdDirectoryRestartInfo, FileDispositionInfoEx, FileRenameInfoEx, MaximumFileInfoByHandleClass } FILE_INFO_BY_HANDLE_CLASS, *PFILE_INFO_BY_HANDLE_CLASS; typedef RTL_CRITICAL_SECTION CRITICAL_SECTION; typedef PRTL_CRITICAL_SECTION PCRITICAL_SECTION; typedef PRTL_CRITICAL_SECTION LPCRITICAL_SECTION; typedef RTL_CRITICAL_SECTION_DEBUG CRITICAL_SECTION_DEBUG; typedef PRTL_CRITICAL_SECTION_DEBUG PCRITICAL_SECTION_DEBUG; typedef PRTL_CRITICAL_SECTION_DEBUG LPCRITICAL_SECTION_DEBUG; typedef void (__stdcall *LPOVERLAPPED_COMPLETION_ROUTINE)( DWORD dwErrorCode, DWORD dwNumberOfBytesTransfered, LPOVERLAPPED lpOverlapped ); typedef struct _PROCESS_HEAP_ENTRY { PVOID lpData; DWORD cbData; BYTE cbOverhead; BYTE iRegionIndex; WORD wFlags; union { struct { HANDLE hMem; DWORD dwReserved[ 3 ]; } Block; struct { DWORD dwCommittedSize; DWORD dwUnCommittedSize; LPVOID lpFirstBlock; LPVOID lpLastBlock; } Region; } ; } PROCESS_HEAP_ENTRY, *LPPROCESS_HEAP_ENTRY, *PPROCESS_HEAP_ENTRY; #line 260 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\minwinbase.h" typedef struct _REASON_CONTEXT { ULONG Version; DWORD Flags; union { struct { HMODULE LocalizedReasonModule; ULONG LocalizedReasonId; ULONG ReasonStringCount; LPWSTR *ReasonStrings; } Detailed; LPWSTR SimpleReasonString; } Reason; } REASON_CONTEXT, *PREASON_CONTEXT; #line 289 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\minwinbase.h" typedef DWORD (__stdcall *PTHREAD_START_ROUTINE)( LPVOID lpThreadParameter ); typedef PTHREAD_START_ROUTINE LPTHREAD_START_ROUTINE; typedef LPVOID (__stdcall *PENCLAVE_ROUTINE)( LPVOID lpThreadParameter ); typedef PENCLAVE_ROUTINE LPENCLAVE_ROUTINE; typedef struct _EXCEPTION_DEBUG_INFO { EXCEPTION_RECORD ExceptionRecord; DWORD dwFirstChance; } EXCEPTION_DEBUG_INFO, *LPEXCEPTION_DEBUG_INFO; typedef struct _CREATE_THREAD_DEBUG_INFO { HANDLE hThread; LPVOID lpThreadLocalBase; LPTHREAD_START_ROUTINE lpStartAddress; } CREATE_THREAD_DEBUG_INFO, *LPCREATE_THREAD_DEBUG_INFO; typedef struct _CREATE_PROCESS_DEBUG_INFO { HANDLE hFile; HANDLE hProcess; HANDLE hThread; LPVOID lpBaseOfImage; DWORD dwDebugInfoFileOffset; DWORD nDebugInfoSize; LPVOID lpThreadLocalBase; LPTHREAD_START_ROUTINE lpStartAddress; LPVOID lpImageName; WORD fUnicode; } CREATE_PROCESS_DEBUG_INFO, *LPCREATE_PROCESS_DEBUG_INFO; typedef struct _EXIT_THREAD_DEBUG_INFO { DWORD dwExitCode; } EXIT_THREAD_DEBUG_INFO, *LPEXIT_THREAD_DEBUG_INFO; typedef struct _EXIT_PROCESS_DEBUG_INFO { DWORD dwExitCode; } EXIT_PROCESS_DEBUG_INFO, *LPEXIT_PROCESS_DEBUG_INFO; typedef struct _LOAD_DLL_DEBUG_INFO { HANDLE hFile; LPVOID lpBaseOfDll; DWORD dwDebugInfoFileOffset; DWORD nDebugInfoSize; LPVOID lpImageName; WORD fUnicode; } LOAD_DLL_DEBUG_INFO, *LPLOAD_DLL_DEBUG_INFO; typedef struct _UNLOAD_DLL_DEBUG_INFO { LPVOID lpBaseOfDll; } UNLOAD_DLL_DEBUG_INFO, *LPUNLOAD_DLL_DEBUG_INFO; typedef struct _OUTPUT_DEBUG_STRING_INFO { LPSTR lpDebugStringData; WORD fUnicode; WORD nDebugStringLength; } OUTPUT_DEBUG_STRING_INFO, *LPOUTPUT_DEBUG_STRING_INFO; typedef struct _RIP_INFO { DWORD dwError; DWORD dwType; } RIP_INFO, *LPRIP_INFO; typedef struct _DEBUG_EVENT { DWORD dwDebugEventCode; DWORD dwProcessId; DWORD dwThreadId; union { EXCEPTION_DEBUG_INFO Exception; CREATE_THREAD_DEBUG_INFO CreateThread; CREATE_PROCESS_DEBUG_INFO CreateProcessInfo; EXIT_THREAD_DEBUG_INFO ExitThread; EXIT_PROCESS_DEBUG_INFO ExitProcess; LOAD_DLL_DEBUG_INFO LoadDll; UNLOAD_DLL_DEBUG_INFO UnloadDll; OUTPUT_DEBUG_STRING_INFO DebugString; RIP_INFO RipInfo; } u; } DEBUG_EVENT, *LPDEBUG_EVENT; typedef PCONTEXT LPCONTEXT; #line 413 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\minwinbase.h" #line 424 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\minwinbase.h" #pragma warning(pop) #line 459 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\minwinbase.h" #line 36 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\processenv.h" #pragma once #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetEnvironmentStringsW( LPWCH NewEnvironment ); #pragma endregion #pragma region PC Family or OneCore Family __declspec(dllimport) HANDLE __stdcall GetStdHandle( DWORD nStdHandle ); __declspec(dllimport) BOOL __stdcall SetStdHandle( DWORD nStdHandle, HANDLE hHandle ); __declspec(dllimport) BOOL __stdcall SetStdHandleEx( DWORD nStdHandle, HANDLE hHandle, PHANDLE phPrevValue ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) LPSTR __stdcall GetCommandLineA( void ); __declspec(dllimport) LPWSTR __stdcall GetCommandLineW( void ); __declspec(dllimport) LPCH __stdcall GetEnvironmentStrings( void ); __declspec(dllimport) LPWCH __stdcall GetEnvironmentStringsW( void ); __declspec(dllimport) BOOL __stdcall FreeEnvironmentStringsA( LPCH penv ); __declspec(dllimport) BOOL __stdcall FreeEnvironmentStringsW( LPWCH penv ); __declspec(dllimport) DWORD __stdcall GetEnvironmentVariableA( LPCSTR lpName, LPSTR lpBuffer, DWORD nSize ); __declspec(dllimport) DWORD __stdcall GetEnvironmentVariableW( LPCWSTR lpName, LPWSTR lpBuffer, DWORD nSize ); __declspec(dllimport) BOOL __stdcall SetEnvironmentVariableA( LPCSTR lpName, LPCSTR lpValue ); __declspec(dllimport) BOOL __stdcall SetEnvironmentVariableW( LPCWSTR lpName, LPCWSTR lpValue ); __declspec(dllimport) DWORD __stdcall ExpandEnvironmentStringsA( LPCSTR lpSrc, LPSTR lpDst, DWORD nSize ); __declspec(dllimport) DWORD __stdcall ExpandEnvironmentStringsW( LPCWSTR lpSrc, LPWSTR lpDst, DWORD nSize ); __declspec(dllimport) BOOL __stdcall SetCurrentDirectoryA( LPCSTR lpPathName ); __declspec(dllimport) BOOL __stdcall SetCurrentDirectoryW( LPCWSTR lpPathName ); __declspec(dllimport) DWORD __stdcall GetCurrentDirectoryA( DWORD nBufferLength, LPSTR lpBuffer ); __declspec(dllimport) DWORD __stdcall GetCurrentDirectoryW( DWORD nBufferLength, LPWSTR lpBuffer ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall SearchPathW( LPCWSTR lpPath, LPCWSTR lpFileName, LPCWSTR lpExtension, DWORD nBufferLength, LPWSTR lpBuffer, LPWSTR* lpFilePart ); __declspec(dllimport) DWORD __stdcall SearchPathA( LPCSTR lpPath, LPCSTR lpFileName, LPCSTR lpExtension, DWORD nBufferLength, LPSTR lpBuffer, LPSTR* lpFilePart ); __declspec(dllimport) BOOL __stdcall NeedCurrentDirectoryForExePathA( LPCSTR ExeName ); __declspec(dllimport) BOOL __stdcall NeedCurrentDirectoryForExePathW( LPCWSTR ExeName ); #pragma endregion #line 42 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\fileapi.h" #pragma once #pragma region Application Family or OneCore Family #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) LONG __stdcall CompareFileTime( const FILETIME* lpFileTime1, const FILETIME* lpFileTime2 ); __declspec(dllimport) BOOL __stdcall CreateDirectoryA( LPCSTR lpPathName, LPSECURITY_ATTRIBUTES lpSecurityAttributes ); __declspec(dllimport) BOOL __stdcall CreateDirectoryW( LPCWSTR lpPathName, LPSECURITY_ATTRIBUTES lpSecurityAttributes ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HANDLE __stdcall CreateFileA( LPCSTR lpFileName, DWORD dwDesiredAccess, DWORD dwShareMode, LPSECURITY_ATTRIBUTES lpSecurityAttributes, DWORD dwCreationDisposition, DWORD dwFlagsAndAttributes, HANDLE hTemplateFile ); __declspec(dllimport) HANDLE __stdcall CreateFileW( LPCWSTR lpFileName, DWORD dwDesiredAccess, DWORD dwShareMode, LPSECURITY_ATTRIBUTES lpSecurityAttributes, DWORD dwCreationDisposition, DWORD dwFlagsAndAttributes, HANDLE hTemplateFile ); __declspec(dllimport) BOOL __stdcall DefineDosDeviceW( DWORD dwFlags, LPCWSTR lpDeviceName, LPCWSTR lpTargetPath ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall DeleteFileA( LPCSTR lpFileName ); __declspec(dllimport) BOOL __stdcall DeleteFileW( LPCWSTR lpFileName ); __declspec(dllimport) BOOL __stdcall DeleteVolumeMountPointW( LPCWSTR lpszVolumeMountPoint ); __declspec(dllimport) BOOL __stdcall FileTimeToLocalFileTime( const FILETIME* lpFileTime, LPFILETIME lpLocalFileTime ); __declspec(dllimport) BOOL __stdcall FindClose( HANDLE hFindFile ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall FindCloseChangeNotification( HANDLE hChangeHandle ); __declspec(dllimport) HANDLE __stdcall FindFirstChangeNotificationA( LPCSTR lpPathName, BOOL bWatchSubtree, DWORD dwNotifyFilter ); __declspec(dllimport) HANDLE __stdcall FindFirstChangeNotificationW( LPCWSTR lpPathName, BOOL bWatchSubtree, DWORD dwNotifyFilter ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) HANDLE __stdcall FindFirstFileA( LPCSTR lpFileName, LPWIN32_FIND_DATAA lpFindFileData ); __declspec(dllimport) HANDLE __stdcall FindFirstFileW( LPCWSTR lpFileName, LPWIN32_FIND_DATAW lpFindFileData ); __declspec(dllimport) HANDLE __stdcall FindFirstFileExA( LPCSTR lpFileName, FINDEX_INFO_LEVELS fInfoLevelId, LPVOID lpFindFileData, FINDEX_SEARCH_OPS fSearchOp, LPVOID lpSearchFilter, DWORD dwAdditionalFlags ); __declspec(dllimport) HANDLE __stdcall FindFirstFileExW( LPCWSTR lpFileName, FINDEX_INFO_LEVELS fInfoLevelId, LPVOID lpFindFileData, FINDEX_SEARCH_OPS fSearchOp, LPVOID lpSearchFilter, DWORD dwAdditionalFlags ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HANDLE __stdcall FindFirstVolumeW( LPWSTR lpszVolumeName, DWORD cchBufferLength ); __declspec(dllimport) BOOL __stdcall FindNextChangeNotification( HANDLE hChangeHandle ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall FindNextFileA( HANDLE hFindFile, LPWIN32_FIND_DATAA lpFindFileData ); __declspec(dllimport) BOOL __stdcall FindNextFileW( HANDLE hFindFile, LPWIN32_FIND_DATAW lpFindFileData ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall FindNextVolumeW( HANDLE hFindVolume, LPWSTR lpszVolumeName, DWORD cchBufferLength ); __declspec(dllimport) BOOL __stdcall FindVolumeClose( HANDLE hFindVolume ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall FlushFileBuffers( HANDLE hFile ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetDiskFreeSpaceA( LPCSTR lpRootPathName, LPDWORD lpSectorsPerCluster, LPDWORD lpBytesPerSector, LPDWORD lpNumberOfFreeClusters, LPDWORD lpTotalNumberOfClusters ); __declspec(dllimport) BOOL __stdcall GetDiskFreeSpaceW( LPCWSTR lpRootPathName, LPDWORD lpSectorsPerCluster, LPDWORD lpBytesPerSector, LPDWORD lpNumberOfFreeClusters, LPDWORD lpTotalNumberOfClusters ); __declspec(dllimport) BOOL __stdcall GetDiskFreeSpaceExA( LPCSTR lpDirectoryName, PULARGE_INTEGER lpFreeBytesAvailableToCaller, PULARGE_INTEGER lpTotalNumberOfBytes, PULARGE_INTEGER lpTotalNumberOfFreeBytes ); __declspec(dllimport) BOOL __stdcall GetDiskFreeSpaceExW( LPCWSTR lpDirectoryName, PULARGE_INTEGER lpFreeBytesAvailableToCaller, PULARGE_INTEGER lpTotalNumberOfBytes, PULARGE_INTEGER lpTotalNumberOfFreeBytes ); __declspec(dllimport) UINT __stdcall GetDriveTypeA( LPCSTR lpRootPathName ); __declspec(dllimport) UINT __stdcall GetDriveTypeW( LPCWSTR lpRootPathName ); #pragma endregion #pragma region Application Family or OneCore Family typedef struct _WIN32_FILE_ATTRIBUTE_DATA { DWORD dwFileAttributes; FILETIME ftCreationTime; FILETIME ftLastAccessTime; FILETIME ftLastWriteTime; DWORD nFileSizeHigh; DWORD nFileSizeLow; } WIN32_FILE_ATTRIBUTE_DATA, *LPWIN32_FILE_ATTRIBUTE_DATA; __declspec(dllimport) DWORD __stdcall GetFileAttributesA( LPCSTR lpFileName ); __declspec(dllimport) DWORD __stdcall GetFileAttributesW( LPCWSTR lpFileName ); __declspec(dllimport) BOOL __stdcall GetFileAttributesExA( LPCSTR lpFileName, GET_FILEEX_INFO_LEVELS fInfoLevelId, LPVOID lpFileInformation ); __declspec(dllimport) BOOL __stdcall GetFileAttributesExW( LPCWSTR lpFileName, GET_FILEEX_INFO_LEVELS fInfoLevelId, LPVOID lpFileInformation ); #pragma endregion #pragma region Desktop Family or OneCore Family typedef struct _BY_HANDLE_FILE_INFORMATION { DWORD dwFileAttributes; FILETIME ftCreationTime; FILETIME ftLastAccessTime; FILETIME ftLastWriteTime; DWORD dwVolumeSerialNumber; DWORD nFileSizeHigh; DWORD nFileSizeLow; DWORD nNumberOfLinks; DWORD nFileIndexHigh; DWORD nFileIndexLow; } BY_HANDLE_FILE_INFORMATION, *PBY_HANDLE_FILE_INFORMATION, *LPBY_HANDLE_FILE_INFORMATION; __declspec(dllimport) BOOL __stdcall GetFileInformationByHandle( HANDLE hFile, LPBY_HANDLE_FILE_INFORMATION lpFileInformation ); __declspec(dllimport) DWORD __stdcall GetFileSize( HANDLE hFile, LPDWORD lpFileSizeHigh ); #pragma endregion #pragma region Application Family __declspec(dllimport) BOOL __stdcall GetFileSizeEx( HANDLE hFile, PLARGE_INTEGER lpFileSize ); __declspec(dllimport) DWORD __stdcall GetFileType( HANDLE hFile ); __declspec(dllimport) DWORD __stdcall GetFinalPathNameByHandleA( HANDLE hFile, LPSTR lpszFilePath, DWORD cchFilePath, DWORD dwFlags ); __declspec(dllimport) DWORD __stdcall GetFinalPathNameByHandleW( HANDLE hFile, LPWSTR lpszFilePath, DWORD cchFilePath, DWORD dwFlags ); __declspec(dllimport) BOOL __stdcall GetFileTime( HANDLE hFile, LPFILETIME lpCreationTime, LPFILETIME lpLastAccessTime, LPFILETIME lpLastWriteTime ); __declspec(dllimport) DWORD __stdcall GetFullPathNameW( LPCWSTR lpFileName, DWORD nBufferLength, LPWSTR lpBuffer, LPWSTR* lpFilePart ); __declspec(dllimport) DWORD __stdcall GetFullPathNameA( LPCSTR lpFileName, DWORD nBufferLength, LPSTR lpBuffer, LPSTR* lpFilePart ); __declspec(dllimport) DWORD __stdcall GetLogicalDrives( void ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetLogicalDriveStringsW( DWORD nBufferLength, LPWSTR lpBuffer ); __declspec(dllimport) DWORD __stdcall GetLongPathNameA( LPCSTR lpszShortPath, LPSTR lpszLongPath, DWORD cchBuffer ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetLongPathNameW( LPCWSTR lpszShortPath, LPWSTR lpszLongPath, DWORD cchBuffer ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetShortPathNameW( LPCWSTR lpszLongPath, LPWSTR lpszShortPath, DWORD cchBuffer ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) UINT __stdcall GetTempFileNameW( LPCWSTR lpPathName, LPCWSTR lpPrefixString, UINT uUnique, LPWSTR lpTempFileName ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetVolumeInformationByHandleW( HANDLE hFile, LPWSTR lpVolumeNameBuffer, DWORD nVolumeNameSize, LPDWORD lpVolumeSerialNumber, LPDWORD lpMaximumComponentLength, LPDWORD lpFileSystemFlags, LPWSTR lpFileSystemNameBuffer, DWORD nFileSystemNameSize ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetVolumeInformationW( LPCWSTR lpRootPathName, LPWSTR lpVolumeNameBuffer, DWORD nVolumeNameSize, LPDWORD lpVolumeSerialNumber, LPDWORD lpMaximumComponentLength, LPDWORD lpFileSystemFlags, LPWSTR lpFileSystemNameBuffer, DWORD nFileSystemNameSize ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetVolumePathNameW( LPCWSTR lpszFileName, LPWSTR lpszVolumePathName, DWORD cchBufferLength ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall LocalFileTimeToFileTime( const FILETIME* lpLocalFileTime, LPFILETIME lpFileTime ); __declspec(dllimport) BOOL __stdcall LockFile( HANDLE hFile, DWORD dwFileOffsetLow, DWORD dwFileOffsetHigh, DWORD nNumberOfBytesToLockLow, DWORD nNumberOfBytesToLockHigh ); __declspec(dllimport) BOOL __stdcall LockFileEx( HANDLE hFile, DWORD dwFlags, DWORD dwReserved, DWORD nNumberOfBytesToLockLow, DWORD nNumberOfBytesToLockHigh, LPOVERLAPPED lpOverlapped ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall QueryDosDeviceW( LPCWSTR lpDeviceName, LPWSTR lpTargetPath, DWORD ucchMax ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall ReadFile( HANDLE hFile, LPVOID lpBuffer, DWORD nNumberOfBytesToRead, LPDWORD lpNumberOfBytesRead, LPOVERLAPPED lpOverlapped ); __declspec(dllimport) BOOL __stdcall ReadFileEx( HANDLE hFile, LPVOID lpBuffer, DWORD nNumberOfBytesToRead, LPOVERLAPPED lpOverlapped, LPOVERLAPPED_COMPLETION_ROUTINE lpCompletionRoutine ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall ReadFileScatter( HANDLE hFile, FILE_SEGMENT_ELEMENT aSegmentArray[], DWORD nNumberOfBytesToRead, LPDWORD lpReserved, LPOVERLAPPED lpOverlapped ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall RemoveDirectoryA( LPCSTR lpPathName ); __declspec(dllimport) BOOL __stdcall RemoveDirectoryW( LPCWSTR lpPathName ); __declspec(dllimport) BOOL __stdcall SetEndOfFile( HANDLE hFile ); __declspec(dllimport) BOOL __stdcall SetFileAttributesA( LPCSTR lpFileName, DWORD dwFileAttributes ); __declspec(dllimport) BOOL __stdcall SetFileAttributesW( LPCWSTR lpFileName, DWORD dwFileAttributes ); __declspec(dllimport) BOOL __stdcall SetFileInformationByHandle( HANDLE hFile, FILE_INFO_BY_HANDLE_CLASS FileInformationClass, LPVOID lpFileInformation, DWORD dwBufferSize ); __declspec(dllimport) DWORD __stdcall SetFilePointer( HANDLE hFile, LONG lDistanceToMove, PLONG lpDistanceToMoveHigh, DWORD dwMoveMethod ); __declspec(dllimport) BOOL __stdcall SetFilePointerEx( HANDLE hFile, LARGE_INTEGER liDistanceToMove, PLARGE_INTEGER lpNewFilePointer, DWORD dwMoveMethod ); __declspec(dllimport) BOOL __stdcall SetFileTime( HANDLE hFile, const FILETIME* lpCreationTime, const FILETIME* lpLastAccessTime, const FILETIME* lpLastWriteTime ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetFileValidData( HANDLE hFile, LONGLONG ValidDataLength ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall UnlockFile( HANDLE hFile, DWORD dwFileOffsetLow, DWORD dwFileOffsetHigh, DWORD nNumberOfBytesToUnlockLow, DWORD nNumberOfBytesToUnlockHigh ); __declspec(dllimport) BOOL __stdcall UnlockFileEx( HANDLE hFile, DWORD dwReserved, DWORD nNumberOfBytesToUnlockLow, DWORD nNumberOfBytesToUnlockHigh, LPOVERLAPPED lpOverlapped ); __declspec(dllimport) BOOL __stdcall WriteFile( HANDLE hFile, LPCVOID lpBuffer, DWORD nNumberOfBytesToWrite, LPDWORD lpNumberOfBytesWritten, LPOVERLAPPED lpOverlapped ); __declspec(dllimport) BOOL __stdcall WriteFileEx( HANDLE hFile, LPCVOID lpBuffer, DWORD nNumberOfBytesToWrite, LPOVERLAPPED lpOverlapped, LPOVERLAPPED_COMPLETION_ROUTINE lpCompletionRoutine ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall WriteFileGather( HANDLE hFile, FILE_SEGMENT_ELEMENT aSegmentArray[], DWORD nNumberOfBytesToWrite, LPDWORD lpReserved, LPOVERLAPPED lpOverlapped ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetTempPathW( DWORD nBufferLength, LPWSTR lpBuffer ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetVolumeNameForVolumeMountPointW( LPCWSTR lpszVolumeMountPoint, LPWSTR lpszVolumeName, DWORD cchBufferLength ); __declspec(dllimport) BOOL __stdcall GetVolumePathNamesForVolumeNameW( LPCWSTR lpszVolumeName, LPWCH lpszVolumePathNames, DWORD cchBufferLength, PDWORD lpcchReturnLength ); #pragma endregion #pragma region Application Family or OneCore Family typedef struct _CREATEFILE2_EXTENDED_PARAMETERS { DWORD dwSize; DWORD dwFileAttributes; DWORD dwFileFlags; DWORD dwSecurityQosFlags; LPSECURITY_ATTRIBUTES lpSecurityAttributes; HANDLE hTemplateFile; } CREATEFILE2_EXTENDED_PARAMETERS, *PCREATEFILE2_EXTENDED_PARAMETERS, *LPCREATEFILE2_EXTENDED_PARAMETERS; __declspec(dllimport) HANDLE __stdcall CreateFile2( LPCWSTR lpFileName, DWORD dwDesiredAccess, DWORD dwShareMode, DWORD dwCreationDisposition, LPCREATEFILE2_EXTENDED_PARAMETERS pCreateExParams ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetFileIoOverlappedRange( HANDLE FileHandle, PUCHAR OverlappedRangeStart, ULONG Length ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetCompressedFileSizeA( LPCSTR lpFileName, LPDWORD lpFileSizeHigh ); __declspec(dllimport) DWORD __stdcall GetCompressedFileSizeW( LPCWSTR lpFileName, LPDWORD lpFileSizeHigh ); #pragma endregion #pragma region Desktop Family or OneCore Family typedef enum _STREAM_INFO_LEVELS { FindStreamInfoStandard, FindStreamInfoMaxInfoLevel } STREAM_INFO_LEVELS; typedef struct _WIN32_FIND_STREAM_DATA { LARGE_INTEGER StreamSize; WCHAR cStreamName[ 260 + 36 ]; } WIN32_FIND_STREAM_DATA, *PWIN32_FIND_STREAM_DATA; __declspec(dllimport) HANDLE __stdcall FindFirstStreamW( LPCWSTR lpFileName, STREAM_INFO_LEVELS InfoLevel, LPVOID lpFindStreamData, DWORD dwFlags ); __declspec(dllimport) BOOL __stdcall FindNextStreamW( HANDLE hFindStream, LPVOID lpFindStreamData ); __declspec(dllimport) BOOL __stdcall AreFileApisANSI( void ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetTempPathA( DWORD nBufferLength, LPSTR lpBuffer ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HANDLE __stdcall FindFirstFileNameW( LPCWSTR lpFileName, DWORD dwFlags, LPDWORD StringLength, PWSTR LinkName ); __declspec(dllimport) BOOL __stdcall FindNextFileNameW( HANDLE hFindStream, LPDWORD StringLength, PWSTR LinkName ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetVolumeInformationA( LPCSTR lpRootPathName, LPSTR lpVolumeNameBuffer, DWORD nVolumeNameSize, LPDWORD lpVolumeSerialNumber, LPDWORD lpMaximumComponentLength, LPDWORD lpFileSystemFlags, LPSTR lpFileSystemNameBuffer, DWORD nFileSystemNameSize ); __declspec(dllimport) UINT __stdcall GetTempFileNameA( LPCSTR lpPathName, LPCSTR lpPrefixString, UINT uUnique, LPSTR lpTempFileName ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) void __stdcall SetFileApisToOEM( void ); __declspec(dllimport) void __stdcall SetFileApisToANSI( void ); #pragma endregion #line 43 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\debugapi.h" #pragma once #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall IsDebuggerPresent( void ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) void __stdcall DebugBreak( void ); __declspec(dllimport) void __stdcall OutputDebugStringA( LPCSTR lpOutputString ); __declspec(dllimport) void __stdcall OutputDebugStringW( LPCWSTR lpOutputString ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall ContinueDebugEvent( DWORD dwProcessId, DWORD dwThreadId, DWORD dwContinueStatus ); __declspec(dllimport) BOOL __stdcall WaitForDebugEvent( LPDEBUG_EVENT lpDebugEvent, DWORD dwMilliseconds ); __declspec(dllimport) BOOL __stdcall DebugActiveProcess( DWORD dwProcessId ); __declspec(dllimport) BOOL __stdcall DebugActiveProcessStop( DWORD dwProcessId ); __declspec(dllimport) BOOL __stdcall CheckRemoteDebuggerPresent( HANDLE hProcess, PBOOL pbDebuggerPresent ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall WaitForDebugEventEx( LPDEBUG_EVENT lpDebugEvent, DWORD dwMilliseconds ); #pragma endregion #line 44 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\utilapiset.h" #pragma once #pragma region Application Family or OneCore Family __declspec(dllimport) PVOID __stdcall EncodePointer( PVOID Ptr ); __declspec(dllimport) PVOID __stdcall DecodePointer( PVOID Ptr ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) PVOID __stdcall EncodeSystemPointer( PVOID Ptr ); __declspec(dllimport) PVOID __stdcall DecodeSystemPointer( PVOID Ptr ); __declspec(dllimport) HRESULT __stdcall EncodeRemotePointer( HANDLE ProcessHandle, PVOID Ptr, PVOID* EncodedPtr ); __declspec(dllimport) HRESULT __stdcall DecodeRemotePointer( HANDLE ProcessHandle, PVOID Ptr, PVOID* DecodedPtr ); #pragma endregion #pragma region PC Family or OneCore Family __declspec(dllimport) BOOL __stdcall Beep( DWORD dwFreq, DWORD dwDuration ); #pragma endregion #line 45 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\handleapi.h" #pragma once #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall CloseHandle( HANDLE hObject ); __declspec(dllimport) BOOL __stdcall DuplicateHandle( HANDLE hSourceProcessHandle, HANDLE hSourceHandle, HANDLE hTargetProcessHandle, LPHANDLE lpTargetHandle, DWORD dwDesiredAccess, BOOL bInheritHandle, DWORD dwOptions ); __declspec(dllimport) BOOL __stdcall CompareObjectHandles( HANDLE hFirstObjectHandle, HANDLE hSecondObjectHandle ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetHandleInformation( HANDLE hObject, LPDWORD lpdwFlags ); __declspec(dllimport) BOOL __stdcall SetHandleInformation( HANDLE hObject, DWORD dwMask, DWORD dwFlags ); #pragma endregion #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\errhandlingapi.h" #pragma once #pragma region Application Family or OneCore Family typedef LONG (__stdcall *PTOP_LEVEL_EXCEPTION_FILTER)( struct _EXCEPTION_POINTERS *ExceptionInfo ); typedef PTOP_LEVEL_EXCEPTION_FILTER LPTOP_LEVEL_EXCEPTION_FILTER; __declspec(dllimport) void __stdcall RaiseException( DWORD dwExceptionCode, DWORD dwExceptionFlags, DWORD nNumberOfArguments, const ULONG_PTR* lpArguments ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) LONG __stdcall UnhandledExceptionFilter( struct _EXCEPTION_POINTERS* ExceptionInfo ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) LPTOP_LEVEL_EXCEPTION_FILTER __stdcall SetUnhandledExceptionFilter( LPTOP_LEVEL_EXCEPTION_FILTER lpTopLevelExceptionFilter ); __declspec(dllimport) DWORD __stdcall GetLastError( void ); __declspec(dllimport) void __stdcall SetLastError( DWORD dwErrCode ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) UINT __stdcall GetErrorMode( void ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) UINT __stdcall SetErrorMode( UINT uMode ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) PVOID __stdcall AddVectoredExceptionHandler( ULONG First, PVECTORED_EXCEPTION_HANDLER Handler ); __declspec(dllimport) ULONG __stdcall RemoveVectoredExceptionHandler( PVOID Handle ); __declspec(dllimport) PVOID __stdcall AddVectoredContinueHandler( ULONG First, PVECTORED_EXCEPTION_HANDLER Handler ); __declspec(dllimport) ULONG __stdcall RemoveVectoredContinueHandler( PVOID Handle ); #line 202 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\errhandlingapi.h" #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) void __stdcall RaiseFailFastException( PEXCEPTION_RECORD pExceptionRecord, PCONTEXT pContextRecord, DWORD dwFlags ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) void __stdcall FatalAppExitA( UINT uAction, LPCSTR lpMessageText ); __declspec(dllimport) void __stdcall FatalAppExitW( UINT uAction, LPCWSTR lpMessageText ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetThreadErrorMode( void ); __declspec(dllimport) BOOL __stdcall SetThreadErrorMode( DWORD dwNewMode, LPDWORD lpOldMode ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) void __stdcall TerminateProcessOnMemoryExhaustion( SIZE_T FailedAllocationSize ); #pragma endregion #line 47 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\fibersapi.h" #pragma once #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall FlsAlloc( PFLS_CALLBACK_FUNCTION lpCallback ); __declspec(dllimport) PVOID __stdcall FlsGetValue( DWORD dwFlsIndex ); __declspec(dllimport) BOOL __stdcall FlsSetValue( DWORD dwFlsIndex, PVOID lpFlsData ); __declspec(dllimport) BOOL __stdcall FlsFree( DWORD dwFlsIndex ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall IsThreadAFiber( void ); #pragma endregion #line 48 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\namedpipeapi.h" #pragma once __declspec(dllimport) BOOL __stdcall CreatePipe( PHANDLE hReadPipe, PHANDLE hWritePipe, LPSECURITY_ATTRIBUTES lpPipeAttributes, DWORD nSize ); __declspec(dllimport) BOOL __stdcall ConnectNamedPipe( HANDLE hNamedPipe, LPOVERLAPPED lpOverlapped ); __declspec(dllimport) BOOL __stdcall DisconnectNamedPipe( HANDLE hNamedPipe ); __declspec(dllimport) BOOL __stdcall SetNamedPipeHandleState( HANDLE hNamedPipe, LPDWORD lpMode, LPDWORD lpMaxCollectionCount, LPDWORD lpCollectDataTimeout ); __declspec(dllimport) BOOL __stdcall PeekNamedPipe( HANDLE hNamedPipe, LPVOID lpBuffer, DWORD nBufferSize, LPDWORD lpBytesRead, LPDWORD lpTotalBytesAvail, LPDWORD lpBytesLeftThisMessage ); __declspec(dllimport) BOOL __stdcall TransactNamedPipe( HANDLE hNamedPipe, LPVOID lpInBuffer, DWORD nInBufferSize, LPVOID lpOutBuffer, DWORD nOutBufferSize, LPDWORD lpBytesRead, LPOVERLAPPED lpOverlapped ); __declspec(dllimport) HANDLE __stdcall CreateNamedPipeW( LPCWSTR lpName, DWORD dwOpenMode, DWORD dwPipeMode, DWORD nMaxInstances, DWORD nOutBufferSize, DWORD nInBufferSize, DWORD nDefaultTimeOut, LPSECURITY_ATTRIBUTES lpSecurityAttributes ); __declspec(dllimport) BOOL __stdcall WaitNamedPipeW( LPCWSTR lpNamedPipeName, DWORD nTimeOut ); __declspec(dllimport) BOOL __stdcall GetNamedPipeClientComputerNameW( HANDLE Pipe, LPWSTR ClientComputerName, ULONG ClientComputerNameLength ); __declspec(dllimport) BOOL __stdcall ImpersonateNamedPipeClient( HANDLE hNamedPipe ); #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetNamedPipeInfo( HANDLE hNamedPipe, LPDWORD lpFlags, LPDWORD lpOutBufferSize, LPDWORD lpInBufferSize, LPDWORD lpMaxInstances ); __declspec(dllimport) BOOL __stdcall GetNamedPipeHandleStateW( HANDLE hNamedPipe, LPDWORD lpState, LPDWORD lpCurInstances, LPDWORD lpMaxCollectionCount, LPDWORD lpCollectDataTimeout, LPWSTR lpUserName, DWORD nMaxUserNameSize ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall CallNamedPipeW( LPCWSTR lpNamedPipeName, LPVOID lpInBuffer, DWORD nInBufferSize, LPVOID lpOutBuffer, DWORD nOutBufferSize, LPDWORD lpBytesRead, DWORD nTimeOut ); #pragma endregion #line 49 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\profileapi.h" #pragma once #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall QueryPerformanceCounter( LARGE_INTEGER* lpPerformanceCount ); __declspec(dllimport) BOOL __stdcall QueryPerformanceFrequency( LARGE_INTEGER* lpFrequency ); #pragma endregion #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\heapapi.h" #pragma once #pragma warning(push) #pragma warning(disable:4820) #pragma region Desktop Family or OneCore Family typedef struct _HEAP_SUMMARY { DWORD cb; SIZE_T cbAllocated; SIZE_T cbCommitted; SIZE_T cbReserved; SIZE_T cbMaxReserve; } HEAP_SUMMARY, *PHEAP_SUMMARY; typedef PHEAP_SUMMARY LPHEAP_SUMMARY; #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) HANDLE __stdcall HeapCreate( DWORD flOptions, SIZE_T dwInitialSize, SIZE_T dwMaximumSize ); __declspec(dllimport) BOOL __stdcall HeapDestroy( HANDLE hHeap ); __declspec(dllimport) __declspec(allocator) LPVOID __stdcall HeapAlloc( HANDLE hHeap, DWORD dwFlags, SIZE_T dwBytes ); __declspec(dllimport) __declspec(allocator) LPVOID __stdcall HeapReAlloc( HANDLE hHeap, DWORD dwFlags, LPVOID lpMem, SIZE_T dwBytes ); __declspec(dllimport) BOOL __stdcall HeapFree( HANDLE hHeap, DWORD dwFlags, LPVOID lpMem ); __declspec(dllimport) SIZE_T __stdcall HeapSize( HANDLE hHeap, DWORD dwFlags, LPCVOID lpMem ); __declspec(dllimport) HANDLE __stdcall GetProcessHeap( void ); __declspec(dllimport) SIZE_T __stdcall HeapCompact( HANDLE hHeap, DWORD dwFlags ); __declspec(dllimport) BOOL __stdcall HeapSetInformation( HANDLE HeapHandle, HEAP_INFORMATION_CLASS HeapInformationClass, PVOID HeapInformation, SIZE_T HeapInformationLength ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall HeapValidate( HANDLE hHeap, DWORD dwFlags, LPCVOID lpMem ); #pragma endregion #pragma region Desktop Family BOOL __stdcall HeapSummary( HANDLE hHeap, DWORD dwFlags, LPHEAP_SUMMARY lpSummary ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetProcessHeaps( DWORD NumberOfHeaps, PHANDLE ProcessHeaps ); __declspec(dllimport) BOOL __stdcall HeapLock( HANDLE hHeap ); __declspec(dllimport) BOOL __stdcall HeapUnlock( HANDLE hHeap ); __declspec(dllimport) BOOL __stdcall HeapWalk( HANDLE hHeap, LPPROCESS_HEAP_ENTRY lpEntry ); __declspec(dllimport) BOOL __stdcall HeapQueryInformation( HANDLE HeapHandle, HEAP_INFORMATION_CLASS HeapInformationClass, PVOID HeapInformation, SIZE_T HeapInformationLength, PSIZE_T ReturnLength ); #pragma endregion #pragma warning(pop) #line 51 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\ioapiset.h" #pragma once #pragma region Application Family or OneCore Family __declspec(dllimport) HANDLE __stdcall CreateIoCompletionPort( HANDLE FileHandle, HANDLE ExistingCompletionPort, ULONG_PTR CompletionKey, DWORD NumberOfConcurrentThreads ); __declspec(dllimport) BOOL __stdcall GetQueuedCompletionStatus( HANDLE CompletionPort, LPDWORD lpNumberOfBytesTransferred, PULONG_PTR lpCompletionKey, LPOVERLAPPED* lpOverlapped, DWORD dwMilliseconds ); __declspec(dllimport) BOOL __stdcall GetQueuedCompletionStatusEx( HANDLE CompletionPort, LPOVERLAPPED_ENTRY lpCompletionPortEntries, ULONG ulCount, PULONG ulNumEntriesRemoved, DWORD dwMilliseconds, BOOL fAlertable ); __declspec(dllimport) BOOL __stdcall PostQueuedCompletionStatus( HANDLE CompletionPort, DWORD dwNumberOfBytesTransferred, ULONG_PTR dwCompletionKey, LPOVERLAPPED lpOverlapped ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall DeviceIoControl( HANDLE hDevice, DWORD dwIoControlCode, LPVOID lpInBuffer, DWORD nInBufferSize, LPVOID lpOutBuffer, DWORD nOutBufferSize, LPDWORD lpBytesReturned, LPOVERLAPPED lpOverlapped ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetOverlappedResult( HANDLE hFile, LPOVERLAPPED lpOverlapped, LPDWORD lpNumberOfBytesTransferred, BOOL bWait ); __declspec(dllimport) BOOL __stdcall CancelIoEx( HANDLE hFile, LPOVERLAPPED lpOverlapped ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall CancelIo( HANDLE hFile ); __declspec(dllimport) BOOL __stdcall GetOverlappedResultEx( HANDLE hFile, LPOVERLAPPED lpOverlapped, LPDWORD lpNumberOfBytesTransferred, DWORD dwMilliseconds, BOOL bAlertable ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall CancelSynchronousIo( HANDLE hThread ); #pragma endregion #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\synchapi.h" #pragma once #pragma region Application or OneCore Family typedef RTL_SRWLOCK SRWLOCK, *PSRWLOCK; #pragma endregion #pragma region Application or OneCore Family __declspec(dllimport) void __stdcall InitializeSRWLock( PSRWLOCK SRWLock ); __declspec(dllimport) void __stdcall ReleaseSRWLockExclusive( PSRWLOCK SRWLock ); __declspec(dllimport) void __stdcall ReleaseSRWLockShared( PSRWLOCK SRWLock ); __declspec(dllimport) void __stdcall AcquireSRWLockExclusive( PSRWLOCK SRWLock ); __declspec(dllimport) void __stdcall AcquireSRWLockShared( PSRWLOCK SRWLock ); __declspec(dllimport) BOOLEAN __stdcall TryAcquireSRWLockExclusive( PSRWLOCK SRWLock ); __declspec(dllimport) BOOLEAN __stdcall TryAcquireSRWLockShared( PSRWLOCK SRWLock ); #line 119 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\synchapi.h" __declspec(dllimport) void __stdcall InitializeCriticalSection( LPCRITICAL_SECTION lpCriticalSection ); __declspec(dllimport) void __stdcall EnterCriticalSection( LPCRITICAL_SECTION lpCriticalSection ); __declspec(dllimport) void __stdcall LeaveCriticalSection( LPCRITICAL_SECTION lpCriticalSection ); __declspec(dllimport) BOOL __stdcall InitializeCriticalSectionAndSpinCount( LPCRITICAL_SECTION lpCriticalSection, DWORD dwSpinCount ); __declspec(dllimport) BOOL __stdcall InitializeCriticalSectionEx( LPCRITICAL_SECTION lpCriticalSection, DWORD dwSpinCount, DWORD Flags ); __declspec(dllimport) DWORD __stdcall SetCriticalSectionSpinCount( LPCRITICAL_SECTION lpCriticalSection, DWORD dwSpinCount ); __declspec(dllimport) BOOL __stdcall TryEnterCriticalSection( LPCRITICAL_SECTION lpCriticalSection ); __declspec(dllimport) void __stdcall DeleteCriticalSection( LPCRITICAL_SECTION lpCriticalSection ); typedef RTL_RUN_ONCE INIT_ONCE; typedef PRTL_RUN_ONCE PINIT_ONCE; typedef PRTL_RUN_ONCE LPINIT_ONCE; typedef BOOL (__stdcall *PINIT_ONCE_FN) ( PINIT_ONCE InitOnce, PVOID Parameter, PVOID *Context ); __declspec(dllimport) void __stdcall InitOnceInitialize( PINIT_ONCE InitOnce ); __declspec(dllimport) BOOL __stdcall InitOnceExecuteOnce( PINIT_ONCE InitOnce, PINIT_ONCE_FN InitFn, PVOID Parameter, LPVOID* Context ); __declspec(dllimport) BOOL __stdcall InitOnceBeginInitialize( LPINIT_ONCE lpInitOnce, DWORD dwFlags, PBOOL fPending, LPVOID* lpContext ); __declspec(dllimport) BOOL __stdcall InitOnceComplete( LPINIT_ONCE lpInitOnce, DWORD dwFlags, LPVOID lpContext ); typedef RTL_CONDITION_VARIABLE CONDITION_VARIABLE, *PCONDITION_VARIABLE; __declspec(dllimport) void __stdcall InitializeConditionVariable( PCONDITION_VARIABLE ConditionVariable ); __declspec(dllimport) void __stdcall WakeConditionVariable( PCONDITION_VARIABLE ConditionVariable ); __declspec(dllimport) void __stdcall WakeAllConditionVariable( PCONDITION_VARIABLE ConditionVariable ); __declspec(dllimport) BOOL __stdcall SleepConditionVariableCS( PCONDITION_VARIABLE ConditionVariable, PCRITICAL_SECTION CriticalSection, DWORD dwMilliseconds ); __declspec(dllimport) BOOL __stdcall SleepConditionVariableSRW( PCONDITION_VARIABLE ConditionVariable, PSRWLOCK SRWLock, DWORD dwMilliseconds, ULONG Flags ); __declspec(dllimport) BOOL __stdcall SetEvent( HANDLE hEvent ); __declspec(dllimport) BOOL __stdcall ResetEvent( HANDLE hEvent ); __declspec(dllimport) BOOL __stdcall ReleaseSemaphore( HANDLE hSemaphore, LONG lReleaseCount, LPLONG lpPreviousCount ); __declspec(dllimport) BOOL __stdcall ReleaseMutex( HANDLE hMutex ); __declspec(dllimport) DWORD __stdcall WaitForSingleObject( HANDLE hHandle, DWORD dwMilliseconds ); __declspec(dllimport) DWORD __stdcall SleepEx( DWORD dwMilliseconds, BOOL bAlertable ); __declspec(dllimport) DWORD __stdcall WaitForSingleObjectEx( HANDLE hHandle, DWORD dwMilliseconds, BOOL bAlertable ); __declspec(dllimport) DWORD __stdcall WaitForMultipleObjectsEx( DWORD nCount, const HANDLE* lpHandles, BOOL bWaitAll, DWORD dwMilliseconds, BOOL bAlertable ); __declspec(dllimport) HANDLE __stdcall CreateMutexA( LPSECURITY_ATTRIBUTES lpMutexAttributes, BOOL bInitialOwner, LPCSTR lpName ); __declspec(dllimport) HANDLE __stdcall CreateMutexW( LPSECURITY_ATTRIBUTES lpMutexAttributes, BOOL bInitialOwner, LPCWSTR lpName ); __declspec(dllimport) HANDLE __stdcall OpenMutexW( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCWSTR lpName ); __declspec(dllimport) HANDLE __stdcall CreateEventA( LPSECURITY_ATTRIBUTES lpEventAttributes, BOOL bManualReset, BOOL bInitialState, LPCSTR lpName ); __declspec(dllimport) HANDLE __stdcall CreateEventW( LPSECURITY_ATTRIBUTES lpEventAttributes, BOOL bManualReset, BOOL bInitialState, LPCWSTR lpName ); __declspec(dllimport) HANDLE __stdcall OpenEventA( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCSTR lpName ); __declspec(dllimport) HANDLE __stdcall OpenEventW( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCWSTR lpName ); __declspec(dllimport) HANDLE __stdcall OpenSemaphoreW( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCWSTR lpName ); typedef void (__stdcall *PTIMERAPCROUTINE)( LPVOID lpArgToCompletionRoutine, DWORD dwTimerLowValue, DWORD dwTimerHighValue ); __declspec(dllimport) HANDLE __stdcall OpenWaitableTimerW( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCWSTR lpTimerName ); BOOL __stdcall SetWaitableTimerEx( HANDLE hTimer, const LARGE_INTEGER* lpDueTime, LONG lPeriod, PTIMERAPCROUTINE pfnCompletionRoutine, LPVOID lpArgToCompletionRoutine, PREASON_CONTEXT WakeContext, ULONG TolerableDelay ); __declspec(dllimport) BOOL __stdcall SetWaitableTimer( HANDLE hTimer, const LARGE_INTEGER* lpDueTime, LONG lPeriod, PTIMERAPCROUTINE pfnCompletionRoutine, LPVOID lpArgToCompletionRoutine, BOOL fResume ); __declspec(dllimport) BOOL __stdcall CancelWaitableTimer( HANDLE hTimer ); __declspec(dllimport) HANDLE __stdcall CreateMutexExA( LPSECURITY_ATTRIBUTES lpMutexAttributes, LPCSTR lpName, DWORD dwFlags, DWORD dwDesiredAccess ); __declspec(dllimport) HANDLE __stdcall CreateMutexExW( LPSECURITY_ATTRIBUTES lpMutexAttributes, LPCWSTR lpName, DWORD dwFlags, DWORD dwDesiredAccess ); __declspec(dllimport) HANDLE __stdcall CreateEventExA( LPSECURITY_ATTRIBUTES lpEventAttributes, LPCSTR lpName, DWORD dwFlags, DWORD dwDesiredAccess ); __declspec(dllimport) HANDLE __stdcall CreateEventExW( LPSECURITY_ATTRIBUTES lpEventAttributes, LPCWSTR lpName, DWORD dwFlags, DWORD dwDesiredAccess ); __declspec(dllimport) HANDLE __stdcall CreateSemaphoreExW( LPSECURITY_ATTRIBUTES lpSemaphoreAttributes, LONG lInitialCount, LONG lMaximumCount, LPCWSTR lpName, DWORD dwFlags, DWORD dwDesiredAccess ); __declspec(dllimport) HANDLE __stdcall CreateWaitableTimerExW( LPSECURITY_ATTRIBUTES lpTimerAttributes, LPCWSTR lpTimerName, DWORD dwFlags, DWORD dwDesiredAccess ); #pragma endregion #pragma region Desktop or OneCore Family typedef RTL_BARRIER SYNCHRONIZATION_BARRIER; typedef PRTL_BARRIER PSYNCHRONIZATION_BARRIER; typedef PRTL_BARRIER LPSYNCHRONIZATION_BARRIER; BOOL __stdcall EnterSynchronizationBarrier( LPSYNCHRONIZATION_BARRIER lpBarrier, DWORD dwFlags ); BOOL __stdcall InitializeSynchronizationBarrier( LPSYNCHRONIZATION_BARRIER lpBarrier, LONG lTotalThreads, LONG lSpinCount ); BOOL __stdcall DeleteSynchronizationBarrier( LPSYNCHRONIZATION_BARRIER lpBarrier ); #pragma endregion #pragma region Application or OneCore Family __declspec(dllimport) void __stdcall Sleep( DWORD dwMilliseconds ); BOOL __stdcall WaitOnAddress( volatile void* Address, PVOID CompareAddress, SIZE_T AddressSize, DWORD dwMilliseconds ); void __stdcall WakeByAddressSingle( PVOID Address ); void __stdcall WakeByAddressAll( PVOID Address ); #pragma endregion #pragma region Desktop or OneCore Family __declspec(dllimport) DWORD __stdcall SignalObjectAndWait( HANDLE hObjectToSignal, HANDLE hObjectToWaitOn, DWORD dwMilliseconds, BOOL bAlertable ); #pragma endregion #pragma region Application or OneCore Family __declspec(dllimport) DWORD __stdcall WaitForMultipleObjects( DWORD nCount, const HANDLE* lpHandles, BOOL bWaitAll, DWORD dwMilliseconds ); __declspec(dllimport) HANDLE __stdcall CreateSemaphoreW( LPSECURITY_ATTRIBUTES lpSemaphoreAttributes, LONG lInitialCount, LONG lMaximumCount, LPCWSTR lpName ); __declspec(dllimport) HANDLE __stdcall CreateWaitableTimerW( LPSECURITY_ATTRIBUTES lpTimerAttributes, BOOL bManualReset, LPCWSTR lpTimerName ); #pragma endregion #line 53 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\interlockedapi.h" #pragma once #pragma region Application Family or OneCore Family __declspec(dllimport) void __stdcall InitializeSListHead( PSLIST_HEADER ListHead ); __declspec(dllimport) PSLIST_ENTRY __stdcall InterlockedPopEntrySList( PSLIST_HEADER ListHead ); __declspec(dllimport) PSLIST_ENTRY __stdcall InterlockedPushEntrySList( PSLIST_HEADER ListHead, PSLIST_ENTRY ListEntry ); __declspec(dllimport) PSLIST_ENTRY __stdcall InterlockedPushListSListEx( PSLIST_HEADER ListHead, PSLIST_ENTRY List, PSLIST_ENTRY ListEnd, ULONG Count ); __declspec(dllimport) PSLIST_ENTRY __stdcall InterlockedFlushSList( PSLIST_HEADER ListHead ); __declspec(dllimport) USHORT __stdcall QueryDepthSList( PSLIST_HEADER ListHead ); #pragma endregion #line 54 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\processthreadsapi.h" #pragma once #pragma region Application Family or OneCore Family typedef struct _PROCESS_INFORMATION { HANDLE hProcess; HANDLE hThread; DWORD dwProcessId; DWORD dwThreadId; } PROCESS_INFORMATION, *PPROCESS_INFORMATION, *LPPROCESS_INFORMATION; typedef struct _STARTUPINFOA { DWORD cb; LPSTR lpReserved; LPSTR lpDesktop; LPSTR lpTitle; DWORD dwX; DWORD dwY; DWORD dwXSize; DWORD dwYSize; DWORD dwXCountChars; DWORD dwYCountChars; DWORD dwFillAttribute; DWORD dwFlags; WORD wShowWindow; WORD cbReserved2; LPBYTE lpReserved2; HANDLE hStdInput; HANDLE hStdOutput; HANDLE hStdError; } STARTUPINFOA, *LPSTARTUPINFOA; typedef struct _STARTUPINFOW { DWORD cb; LPWSTR lpReserved; LPWSTR lpDesktop; LPWSTR lpTitle; DWORD dwX; DWORD dwY; DWORD dwXSize; DWORD dwYSize; DWORD dwXCountChars; DWORD dwYCountChars; DWORD dwFillAttribute; DWORD dwFlags; WORD wShowWindow; WORD cbReserved2; LPBYTE lpReserved2; HANDLE hStdInput; HANDLE hStdOutput; HANDLE hStdError; } STARTUPINFOW, *LPSTARTUPINFOW; typedef STARTUPINFOA STARTUPINFO; typedef LPSTARTUPINFOA LPSTARTUPINFO; #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall QueueUserAPC( PAPCFUNC pfnAPC, HANDLE hThread, ULONG_PTR dwData ); __declspec(dllimport) BOOL __stdcall GetProcessTimes( HANDLE hProcess, LPFILETIME lpCreationTime, LPFILETIME lpExitTime, LPFILETIME lpKernelTime, LPFILETIME lpUserTime ); __declspec(dllimport) HANDLE __stdcall GetCurrentProcess( void ); __declspec(dllimport) DWORD __stdcall GetCurrentProcessId( void ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) __declspec(noreturn) void __stdcall ExitProcess( UINT uExitCode ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall TerminateProcess( HANDLE hProcess, UINT uExitCode ); __declspec(dllimport) BOOL __stdcall GetExitCodeProcess( HANDLE hProcess, LPDWORD lpExitCode ); __declspec(dllimport) BOOL __stdcall SwitchToThread( void ); __declspec(dllimport) HANDLE __stdcall CreateThread( LPSECURITY_ATTRIBUTES lpThreadAttributes, SIZE_T dwStackSize, LPTHREAD_START_ROUTINE lpStartAddress, LPVOID lpParameter, DWORD dwCreationFlags, LPDWORD lpThreadId ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HANDLE __stdcall CreateRemoteThread( HANDLE hProcess, LPSECURITY_ATTRIBUTES lpThreadAttributes, SIZE_T dwStackSize, LPTHREAD_START_ROUTINE lpStartAddress, LPVOID lpParameter, DWORD dwCreationFlags, LPDWORD lpThreadId ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) HANDLE __stdcall GetCurrentThread( void ); __declspec(dllimport) DWORD __stdcall GetCurrentThreadId( void ); __declspec(dllimport) HANDLE __stdcall OpenThread( DWORD dwDesiredAccess, BOOL bInheritHandle, DWORD dwThreadId ); __declspec(dllimport) BOOL __stdcall SetThreadPriority( HANDLE hThread, int nPriority ); __declspec(dllimport) BOOL __stdcall SetThreadPriorityBoost( HANDLE hThread, BOOL bDisablePriorityBoost ); __declspec(dllimport) BOOL __stdcall GetThreadPriorityBoost( HANDLE hThread, PBOOL pDisablePriorityBoost ); __declspec(dllimport) int __stdcall GetThreadPriority( HANDLE hThread ); __declspec(dllimport) __declspec(noreturn) void __stdcall ExitThread( DWORD dwExitCode ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall TerminateThread( HANDLE hThread, DWORD dwExitCode ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetExitCodeThread( HANDLE hThread, LPDWORD lpExitCode ); __declspec(dllimport) DWORD __stdcall SuspendThread( HANDLE hThread ); __declspec(dllimport) DWORD __stdcall ResumeThread( HANDLE hThread ); __declspec(dllimport) DWORD __stdcall TlsAlloc( void ); __declspec(dllimport) LPVOID __stdcall TlsGetValue( DWORD dwTlsIndex ); __declspec(dllimport) BOOL __stdcall TlsSetValue( DWORD dwTlsIndex, LPVOID lpTlsValue ); __declspec(dllimport) BOOL __stdcall TlsFree( DWORD dwTlsIndex ); __declspec(dllimport) BOOL __stdcall CreateProcessA( LPCSTR lpApplicationName, LPSTR lpCommandLine, LPSECURITY_ATTRIBUTES lpProcessAttributes, LPSECURITY_ATTRIBUTES lpThreadAttributes, BOOL bInheritHandles, DWORD dwCreationFlags, LPVOID lpEnvironment, LPCSTR lpCurrentDirectory, LPSTARTUPINFOA lpStartupInfo, LPPROCESS_INFORMATION lpProcessInformation ); __declspec(dllimport) BOOL __stdcall CreateProcessW( LPCWSTR lpApplicationName, LPWSTR lpCommandLine, LPSECURITY_ATTRIBUTES lpProcessAttributes, LPSECURITY_ATTRIBUTES lpThreadAttributes, BOOL bInheritHandles, DWORD dwCreationFlags, LPVOID lpEnvironment, LPCWSTR lpCurrentDirectory, LPSTARTUPINFOW lpStartupInfo, LPPROCESS_INFORMATION lpProcessInformation ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetProcessShutdownParameters( DWORD dwLevel, DWORD dwFlags ); __declspec(dllimport) DWORD __stdcall GetProcessVersion( DWORD ProcessId ); __declspec(dllimport) void __stdcall GetStartupInfoW( LPSTARTUPINFOW lpStartupInfo ); __declspec(dllimport) BOOL __stdcall CreateProcessAsUserW( HANDLE hToken, LPCWSTR lpApplicationName, LPWSTR lpCommandLine, LPSECURITY_ATTRIBUTES lpProcessAttributes, LPSECURITY_ATTRIBUTES lpThreadAttributes, BOOL bInheritHandles, DWORD dwCreationFlags, LPVOID lpEnvironment, LPCWSTR lpCurrentDirectory, LPSTARTUPINFOW lpStartupInfo, LPPROCESS_INFORMATION lpProcessInformation ); __forceinline HANDLE GetCurrentProcessToken ( void ) { return (HANDLE)(LONG_PTR) -4; } __forceinline HANDLE GetCurrentThreadToken ( void ) { return (HANDLE)(LONG_PTR) -5; } __forceinline HANDLE GetCurrentThreadEffectiveToken ( void ) { return (HANDLE)(LONG_PTR) -6; } #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetThreadToken( PHANDLE Thread, HANDLE Token ); __declspec(dllimport) BOOL __stdcall OpenProcessToken( HANDLE ProcessHandle, DWORD DesiredAccess, PHANDLE TokenHandle ); __declspec(dllimport) BOOL __stdcall OpenThreadToken( HANDLE ThreadHandle, DWORD DesiredAccess, BOOL OpenAsSelf, PHANDLE TokenHandle ); __declspec(dllimport) BOOL __stdcall SetPriorityClass( HANDLE hProcess, DWORD dwPriorityClass ); __declspec(dllimport) DWORD __stdcall GetPriorityClass( HANDLE hProcess ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetThreadStackGuarantee( PULONG StackSizeInBytes ); __declspec(dllimport) BOOL __stdcall ProcessIdToSessionId( DWORD dwProcessId, DWORD* pSessionId ); typedef struct _PROC_THREAD_ATTRIBUTE_LIST *PPROC_THREAD_ATTRIBUTE_LIST, *LPPROC_THREAD_ATTRIBUTE_LIST; #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetProcessId( HANDLE Process ); __declspec(dllimport) DWORD __stdcall GetThreadId( HANDLE Thread ); __declspec(dllimport) void __stdcall FlushProcessWriteBuffers( void ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetProcessIdOfThread( HANDLE Thread ); __declspec(dllimport) BOOL __stdcall InitializeProcThreadAttributeList( LPPROC_THREAD_ATTRIBUTE_LIST lpAttributeList, DWORD dwAttributeCount, DWORD dwFlags, PSIZE_T lpSize ); __declspec(dllimport) void __stdcall DeleteProcThreadAttributeList( LPPROC_THREAD_ATTRIBUTE_LIST lpAttributeList ); __declspec(dllimport) BOOL __stdcall SetProcessAffinityUpdateMode( HANDLE hProcess, DWORD dwFlags ); __declspec(dllimport) BOOL __stdcall QueryProcessAffinityUpdateMode( HANDLE hProcess, LPDWORD lpdwFlags ); __declspec(dllimport) BOOL __stdcall UpdateProcThreadAttribute( LPPROC_THREAD_ATTRIBUTE_LIST lpAttributeList, DWORD dwFlags, DWORD_PTR Attribute, PVOID lpValue, SIZE_T cbSize, PVOID lpPreviousValue, PSIZE_T lpReturnSize ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HANDLE __stdcall CreateRemoteThreadEx( HANDLE hProcess, LPSECURITY_ATTRIBUTES lpThreadAttributes, SIZE_T dwStackSize, LPTHREAD_START_ROUTINE lpStartAddress, LPVOID lpParameter, DWORD dwCreationFlags, LPPROC_THREAD_ATTRIBUTE_LIST lpAttributeList, LPDWORD lpThreadId ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) void __stdcall GetCurrentThreadStackLimits( PULONG_PTR LowLimit, PULONG_PTR HighLimit ); __declspec(dllimport) BOOL __stdcall GetThreadContext( HANDLE hThread, LPCONTEXT lpContext ); __declspec(dllimport) BOOL __stdcall GetProcessMitigationPolicy( HANDLE hProcess, PROCESS_MITIGATION_POLICY MitigationPolicy, PVOID lpBuffer, SIZE_T dwLength ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetThreadContext( HANDLE hThread, const CONTEXT* lpContext ); __declspec(dllimport) BOOL __stdcall SetProcessMitigationPolicy( PROCESS_MITIGATION_POLICY MitigationPolicy, PVOID lpBuffer, SIZE_T dwLength ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall FlushInstructionCache( HANDLE hProcess, LPCVOID lpBaseAddress, SIZE_T dwSize ); __declspec(dllimport) BOOL __stdcall GetThreadTimes( HANDLE hThread, LPFILETIME lpCreationTime, LPFILETIME lpExitTime, LPFILETIME lpKernelTime, LPFILETIME lpUserTime ); __declspec(dllimport) HANDLE __stdcall OpenProcess( DWORD dwDesiredAccess, BOOL bInheritHandle, DWORD dwProcessId ); __declspec(dllimport) BOOL __stdcall IsProcessorFeaturePresent( DWORD ProcessorFeature ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetProcessHandleCount( HANDLE hProcess, PDWORD pdwHandleCount ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetCurrentProcessorNumber( void ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetThreadIdealProcessorEx( HANDLE hThread, PPROCESSOR_NUMBER lpIdealProcessor, PPROCESSOR_NUMBER lpPreviousIdealProcessor ); __declspec(dllimport) BOOL __stdcall GetThreadIdealProcessorEx( HANDLE hThread, PPROCESSOR_NUMBER lpIdealProcessor ); __declspec(dllimport) void __stdcall GetCurrentProcessorNumberEx( PPROCESSOR_NUMBER ProcNumber ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetProcessPriorityBoost( HANDLE hProcess, PBOOL pDisablePriorityBoost ); __declspec(dllimport) BOOL __stdcall SetProcessPriorityBoost( HANDLE hProcess, BOOL bDisablePriorityBoost ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetThreadIOPendingFlag( HANDLE hThread, PBOOL lpIOIsPending ); __declspec(dllimport) BOOL __stdcall GetSystemTimes( PFILETIME lpIdleTime, PFILETIME lpKernelTime, PFILETIME lpUserTime ); #pragma endregion #pragma region Application Family or OneCore Family typedef enum _THREAD_INFORMATION_CLASS { ThreadMemoryPriority, ThreadAbsoluteCpuPriority, ThreadDynamicCodePolicy, ThreadPowerThrottling, ThreadInformationClassMax } THREAD_INFORMATION_CLASS; typedef struct _MEMORY_PRIORITY_INFORMATION { ULONG MemoryPriority; } MEMORY_PRIORITY_INFORMATION, *PMEMORY_PRIORITY_INFORMATION; __declspec(dllimport) BOOL __stdcall GetThreadInformation( HANDLE hThread, THREAD_INFORMATION_CLASS ThreadInformationClass, LPVOID ThreadInformation, DWORD ThreadInformationSize ); __declspec(dllimport) BOOL __stdcall SetThreadInformation( HANDLE hThread, THREAD_INFORMATION_CLASS ThreadInformationClass, LPVOID ThreadInformation, DWORD ThreadInformationSize ); typedef struct _THREAD_POWER_THROTTLING_STATE { ULONG Version; ULONG ControlMask; ULONG StateMask; } THREAD_POWER_THROTTLING_STATE; #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall IsProcessCritical( HANDLE hProcess, PBOOL Critical ); __declspec(dllimport) BOOL __stdcall SetProtectedPolicy( LPCGUID PolicyGuid, ULONG_PTR PolicyValue, PULONG_PTR OldPolicyValue ); __declspec(dllimport) BOOL __stdcall QueryProtectedPolicy( LPCGUID PolicyGuid, PULONG_PTR PolicyValue ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall SetThreadIdealProcessor( HANDLE hThread, DWORD dwIdealProcessor ); #pragma endregion #pragma region Application Family or OneCore Family typedef enum _PROCESS_INFORMATION_CLASS { ProcessMemoryPriority, ProcessMemoryExhaustionInfo, ProcessAppMemoryInfo, ProcessInPrivateInfo, ProcessPowerThrottling, ProcessReservedValue1, ProcessTelemetryCoverageInfo, ProcessProtectionLevelInfo, ProcessInformationClassMax } PROCESS_INFORMATION_CLASS; typedef struct _APP_MEMORY_INFORMATION { ULONG64 AvailableCommit; ULONG64 PrivateCommitUsage; ULONG64 PeakPrivateCommitUsage; ULONG64 TotalCommitUsage; } APP_MEMORY_INFORMATION, *PAPP_MEMORY_INFORMATION; typedef enum _PROCESS_MEMORY_EXHAUSTION_TYPE { PMETypeFailFastOnCommitFailure, PMETypeMax } PROCESS_MEMORY_EXHAUSTION_TYPE, *PPROCESS_MEMORY_EXHAUSTION_TYPE; typedef struct _PROCESS_MEMORY_EXHAUSTION_INFO { USHORT Version; USHORT Reserved; PROCESS_MEMORY_EXHAUSTION_TYPE Type; ULONG_PTR Value; } PROCESS_MEMORY_EXHAUSTION_INFO, *PPROCESS_MEMORY_EXHAUSTION_INFO; typedef struct _PROCESS_POWER_THROTTLING_STATE { ULONG Version; ULONG ControlMask; ULONG StateMask; } PROCESS_POWER_THROTTLING_STATE, *PPROCESS_POWER_THROTTLING_STATE; typedef struct PROCESS_PROTECTION_LEVEL_INFORMATION { DWORD ProtectionLevel; } PROCESS_PROTECTION_LEVEL_INFORMATION; __declspec(dllimport) BOOL __stdcall SetProcessInformation( HANDLE hProcess, PROCESS_INFORMATION_CLASS ProcessInformationClass, LPVOID ProcessInformation, DWORD ProcessInformationSize ); __declspec(dllimport) BOOL __stdcall GetProcessInformation( HANDLE hProcess, PROCESS_INFORMATION_CLASS ProcessInformationClass, LPVOID ProcessInformation, DWORD ProcessInformationSize ); BOOL __stdcall GetSystemCpuSetInformation( PSYSTEM_CPU_SET_INFORMATION Information, ULONG BufferLength, PULONG ReturnedLength, HANDLE Process, ULONG Flags ); BOOL __stdcall GetProcessDefaultCpuSets( HANDLE Process, PULONG CpuSetIds, ULONG CpuSetIdCount, PULONG RequiredIdCount ); BOOL __stdcall SetProcessDefaultCpuSets( HANDLE Process, const ULONG* CpuSetIds, ULONG CpuSetIdCount ); BOOL __stdcall GetThreadSelectedCpuSets( HANDLE Thread, PULONG CpuSetIds, ULONG CpuSetIdCount, PULONG RequiredIdCount ); BOOL __stdcall SetThreadSelectedCpuSets( HANDLE Thread, const ULONG* CpuSetIds, ULONG CpuSetIdCount ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall CreateProcessAsUserA( HANDLE hToken, LPCSTR lpApplicationName, LPSTR lpCommandLine, LPSECURITY_ATTRIBUTES lpProcessAttributes, LPSECURITY_ATTRIBUTES lpThreadAttributes, BOOL bInheritHandles, DWORD dwCreationFlags, LPVOID lpEnvironment, LPCSTR lpCurrentDirectory, LPSTARTUPINFOA lpStartupInfo, LPPROCESS_INFORMATION lpProcessInformation ); __declspec(dllimport) BOOL __stdcall GetProcessShutdownParameters( LPDWORD lpdwLevel, LPDWORD lpdwFlags ); #pragma endregion __declspec(dllimport) HRESULT __stdcall SetThreadDescription( HANDLE hThread, PCWSTR lpThreadDescription ); __declspec(dllimport) HRESULT __stdcall GetThreadDescription( HANDLE hThread, PWSTR* ppszThreadDescription ); #line 55 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\sysinfoapi.h" #pragma once #pragma warning(disable:4514) #pragma warning(disable:4103) #pragma warning(push) #pragma warning(disable:4001) #pragma warning(disable:4201) #pragma warning(disable:4214) #pragma region Application Family or OneCore Family typedef struct _SYSTEM_INFO { union { DWORD dwOemId; struct { WORD wProcessorArchitecture; WORD wReserved; } ; } ; DWORD dwPageSize; LPVOID lpMinimumApplicationAddress; LPVOID lpMaximumApplicationAddress; DWORD_PTR dwActiveProcessorMask; DWORD dwNumberOfProcessors; DWORD dwProcessorType; DWORD dwAllocationGranularity; WORD wProcessorLevel; WORD wProcessorRevision; } SYSTEM_INFO, *LPSYSTEM_INFO; #pragma endregion #pragma region Application Family or OneCore Family typedef struct _MEMORYSTATUSEX { DWORD dwLength; DWORD dwMemoryLoad; DWORDLONG ullTotalPhys; DWORDLONG ullAvailPhys; DWORDLONG ullTotalPageFile; DWORDLONG ullAvailPageFile; DWORDLONG ullTotalVirtual; DWORDLONG ullAvailVirtual; DWORDLONG ullAvailExtendedVirtual; } MEMORYSTATUSEX, *LPMEMORYSTATUSEX; __declspec(dllimport) BOOL __stdcall GlobalMemoryStatusEx( LPMEMORYSTATUSEX lpBuffer ); __declspec(dllimport) void __stdcall GetSystemInfo( LPSYSTEM_INFO lpSystemInfo ); __declspec(dllimport) void __stdcall GetSystemTime( LPSYSTEMTIME lpSystemTime ); __declspec(dllimport) void __stdcall GetSystemTimeAsFileTime( LPFILETIME lpSystemTimeAsFileTime ); __declspec(dllimport) void __stdcall GetLocalTime( LPSYSTEMTIME lpSystemTime ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(deprecated) __declspec(dllimport) DWORD __stdcall GetVersion( void ); __declspec(dllimport) BOOL __stdcall SetLocalTime( const SYSTEMTIME* lpSystemTime ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetTickCount( void ); __declspec(dllimport) ULONGLONG __stdcall GetTickCount64( void ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetSystemTimeAdjustment( PDWORD lpTimeAdjustment, PDWORD lpTimeIncrement, PBOOL lpTimeAdjustmentDisabled ); __declspec(dllimport) BOOL __stdcall GetSystemTimeAdjustmentPrecise( PDWORD64 lpTimeAdjustment, PDWORD64 lpTimeIncrement, PBOOL lpTimeAdjustmentDisabled ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) UINT __stdcall GetSystemDirectoryA( LPSTR lpBuffer, UINT uSize ); __declspec(dllimport) UINT __stdcall GetSystemDirectoryW( LPWSTR lpBuffer, UINT uSize ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) UINT __stdcall GetWindowsDirectoryA( LPSTR lpBuffer, UINT uSize ); __declspec(dllimport) UINT __stdcall GetWindowsDirectoryW( LPWSTR lpBuffer, UINT uSize ); __declspec(dllimport) UINT __stdcall GetSystemWindowsDirectoryA( LPSTR lpBuffer, UINT uSize ); __declspec(dllimport) UINT __stdcall GetSystemWindowsDirectoryW( LPWSTR lpBuffer, UINT uSize ); #pragma endregion #pragma region Desktop Family or OneCore Family typedef enum _COMPUTER_NAME_FORMAT { ComputerNameNetBIOS, ComputerNameDnsHostname, ComputerNameDnsDomain, ComputerNameDnsFullyQualified, ComputerNamePhysicalNetBIOS, ComputerNamePhysicalDnsHostname, ComputerNamePhysicalDnsDomain, ComputerNamePhysicalDnsFullyQualified, ComputerNameMax } COMPUTER_NAME_FORMAT ; #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetComputerNameExA( COMPUTER_NAME_FORMAT NameType, LPSTR lpBuffer, LPDWORD nSize ); __declspec(dllimport) BOOL __stdcall GetComputerNameExW( COMPUTER_NAME_FORMAT NameType, LPWSTR lpBuffer, LPDWORD nSize ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetComputerNameExW( COMPUTER_NAME_FORMAT NameType, LPCWSTR lpBuffer ); __declspec(dllimport) BOOL __stdcall SetSystemTime( const SYSTEMTIME* lpSystemTime ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(deprecated) __declspec(dllimport) BOOL __stdcall GetVersionExA( LPOSVERSIONINFOA lpVersionInformation ); __declspec(deprecated) __declspec(dllimport) BOOL __stdcall GetVersionExW( LPOSVERSIONINFOW lpVersionInformation ); __declspec(dllimport) BOOL __stdcall GetLogicalProcessorInformation( PSYSTEM_LOGICAL_PROCESSOR_INFORMATION Buffer, PDWORD ReturnedLength ); __declspec(dllimport) BOOL __stdcall GetLogicalProcessorInformationEx( LOGICAL_PROCESSOR_RELATIONSHIP RelationshipType, PSYSTEM_LOGICAL_PROCESSOR_INFORMATION_EX Buffer, PDWORD ReturnedLength ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) void __stdcall GetNativeSystemInfo( LPSYSTEM_INFO lpSystemInfo ); __declspec(dllimport) void __stdcall GetSystemTimePreciseAsFileTime( LPFILETIME lpSystemTimeAsFileTime ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetProductInfo( DWORD dwOSMajorVersion, DWORD dwOSMinorVersion, DWORD dwSpMajorVersion, DWORD dwSpMinorVersion, PDWORD pdwReturnedProductType ); __declspec(dllimport) ULONGLONG __stdcall VerSetConditionMask( ULONGLONG ConditionMask, ULONG TypeMask, UCHAR Condition ); __declspec(dllimport) BOOL __stdcall GetOsSafeBootMode( PDWORD Flags ); #pragma endregion #pragma region OneCore Family or App Family __declspec(dllimport) UINT __stdcall EnumSystemFirmwareTables( DWORD FirmwareTableProviderSignature, PVOID pFirmwareTableEnumBuffer, DWORD BufferSize ); __declspec(dllimport) UINT __stdcall GetSystemFirmwareTable( DWORD FirmwareTableProviderSignature, DWORD FirmwareTableID, PVOID pFirmwareTableBuffer, DWORD BufferSize ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall DnsHostnameToComputerNameExW( LPCWSTR Hostname, LPWSTR ComputerName, LPDWORD nSize ); __declspec(dllimport) BOOL __stdcall GetPhysicallyInstalledSystemMemory( PULONGLONG TotalMemoryInKilobytes ); __declspec(dllimport) BOOL __stdcall SetComputerNameEx2W( COMPUTER_NAME_FORMAT NameType, DWORD Flags, LPCWSTR lpBuffer ); __declspec(dllimport) BOOL __stdcall SetSystemTimeAdjustment( DWORD dwTimeAdjustment, BOOL bTimeAdjustmentDisabled ); __declspec(dllimport) BOOL __stdcall SetSystemTimeAdjustmentPrecise( DWORD64 dwTimeAdjustment, BOOL bTimeAdjustmentDisabled ); __declspec(dllimport) BOOL __stdcall InstallELAMCertificateInfo( HANDLE ELAMFile ); #pragma endregion __declspec(dllimport) BOOL __stdcall GetProcessorSystemCycleTime( USHORT Group, PSYSTEM_PROCESSOR_CYCLE_TIME_INFORMATION Buffer, PDWORD ReturnedLength ); #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetOsManufacturingMode( PBOOL pbEnabled ); #pragma endregion #pragma region App Family or OneCore Family __declspec(dllimport) HRESULT __stdcall GetIntegratedDisplaySize( double* sizeInInches ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetComputerNameA( LPCSTR lpComputerName ); __declspec(dllimport) BOOL __stdcall SetComputerNameW( LPCWSTR lpComputerName ); __declspec(dllimport) BOOL __stdcall SetComputerNameExA( COMPUTER_NAME_FORMAT NameType, LPCSTR lpBuffer ); #pragma endregion #pragma warning(pop) #line 700 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\sysinfoapi.h" #line 56 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\memoryapi.h" #pragma once #pragma warning(push) #pragma warning(disable:4668) #pragma region Application Family or OneCore Family #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) LPVOID __stdcall VirtualAlloc( LPVOID lpAddress, SIZE_T dwSize, DWORD flAllocationType, DWORD flProtect ); __declspec(dllimport) BOOL __stdcall VirtualProtect( LPVOID lpAddress, SIZE_T dwSize, DWORD flNewProtect, PDWORD lpflOldProtect ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall VirtualFree( LPVOID lpAddress, SIZE_T dwSize, DWORD dwFreeType ); __declspec(dllimport) SIZE_T __stdcall VirtualQuery( LPCVOID lpAddress, PMEMORY_BASIC_INFORMATION lpBuffer, SIZE_T dwLength ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) LPVOID __stdcall VirtualAllocEx( HANDLE hProcess, LPVOID lpAddress, SIZE_T dwSize, DWORD flAllocationType, DWORD flProtect ); __declspec(dllimport) BOOL __stdcall VirtualProtectEx( HANDLE hProcess, LPVOID lpAddress, SIZE_T dwSize, DWORD flNewProtect, PDWORD lpflOldProtect ); __declspec(dllimport) SIZE_T __stdcall VirtualQueryEx( HANDLE hProcess, LPCVOID lpAddress, PMEMORY_BASIC_INFORMATION lpBuffer, SIZE_T dwLength ); __declspec(dllimport) BOOL __stdcall ReadProcessMemory( HANDLE hProcess, LPCVOID lpBaseAddress, LPVOID lpBuffer, SIZE_T nSize, SIZE_T* lpNumberOfBytesRead ); __declspec(dllimport) BOOL __stdcall WriteProcessMemory( HANDLE hProcess, LPVOID lpBaseAddress, LPCVOID lpBuffer, SIZE_T nSize, SIZE_T* lpNumberOfBytesWritten ); __declspec(dllimport) HANDLE __stdcall CreateFileMappingW( HANDLE hFile, LPSECURITY_ATTRIBUTES lpFileMappingAttributes, DWORD flProtect, DWORD dwMaximumSizeHigh, DWORD dwMaximumSizeLow, LPCWSTR lpName ); __declspec(dllimport) HANDLE __stdcall OpenFileMappingW( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCWSTR lpName ); __declspec(dllimport) LPVOID __stdcall MapViewOfFile( HANDLE hFileMappingObject, DWORD dwDesiredAccess, DWORD dwFileOffsetHigh, DWORD dwFileOffsetLow, SIZE_T dwNumberOfBytesToMap ); __declspec(dllimport) LPVOID __stdcall MapViewOfFileEx( HANDLE hFileMappingObject, DWORD dwDesiredAccess, DWORD dwFileOffsetHigh, DWORD dwFileOffsetLow, SIZE_T dwNumberOfBytesToMap, LPVOID lpBaseAddress ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall VirtualFreeEx( HANDLE hProcess, LPVOID lpAddress, SIZE_T dwSize, DWORD dwFreeType ); __declspec(dllimport) BOOL __stdcall FlushViewOfFile( LPCVOID lpBaseAddress, SIZE_T dwNumberOfBytesToFlush ); __declspec(dllimport) BOOL __stdcall UnmapViewOfFile( LPCVOID lpBaseAddress ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) SIZE_T __stdcall GetLargePageMinimum( void ); __declspec(dllimport) BOOL __stdcall GetProcessWorkingSetSizeEx( HANDLE hProcess, PSIZE_T lpMinimumWorkingSetSize, PSIZE_T lpMaximumWorkingSetSize, PDWORD Flags ); __declspec(dllimport) BOOL __stdcall SetProcessWorkingSetSizeEx( HANDLE hProcess, SIZE_T dwMinimumWorkingSetSize, SIZE_T dwMaximumWorkingSetSize, DWORD Flags ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall VirtualLock( LPVOID lpAddress, SIZE_T dwSize ); __declspec(dllimport) BOOL __stdcall VirtualUnlock( LPVOID lpAddress, SIZE_T dwSize ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) UINT __stdcall GetWriteWatch( DWORD dwFlags, PVOID lpBaseAddress, SIZE_T dwRegionSize, PVOID* lpAddresses, ULONG_PTR* lpdwCount, LPDWORD lpdwGranularity ); __declspec(dllimport) UINT __stdcall ResetWriteWatch( LPVOID lpBaseAddress, SIZE_T dwRegionSize ); #pragma endregion #pragma region Desktop Family or OneCore Family typedef enum _MEMORY_RESOURCE_NOTIFICATION_TYPE { LowMemoryResourceNotification, HighMemoryResourceNotification } MEMORY_RESOURCE_NOTIFICATION_TYPE; __declspec(dllimport) HANDLE __stdcall CreateMemoryResourceNotification( MEMORY_RESOURCE_NOTIFICATION_TYPE NotificationType ); __declspec(dllimport) BOOL __stdcall QueryMemoryResourceNotification( HANDLE ResourceNotificationHandle, PBOOL ResourceState ); __declspec(dllimport) BOOL __stdcall GetSystemFileCacheSize( PSIZE_T lpMinimumFileCacheSize, PSIZE_T lpMaximumFileCacheSize, PDWORD lpFlags ); __declspec(dllimport) BOOL __stdcall SetSystemFileCacheSize( SIZE_T MinimumFileCacheSize, SIZE_T MaximumFileCacheSize, DWORD Flags ); __declspec(dllimport) HANDLE __stdcall CreateFileMappingNumaW( HANDLE hFile, LPSECURITY_ATTRIBUTES lpFileMappingAttributes, DWORD flProtect, DWORD dwMaximumSizeHigh, DWORD dwMaximumSizeLow, LPCWSTR lpName, DWORD nndPreferred ); typedef struct _WIN32_MEMORY_RANGE_ENTRY { PVOID VirtualAddress; SIZE_T NumberOfBytes; } WIN32_MEMORY_RANGE_ENTRY, *PWIN32_MEMORY_RANGE_ENTRY; __declspec(dllimport) BOOL __stdcall PrefetchVirtualMemory( HANDLE hProcess, ULONG_PTR NumberOfEntries, PWIN32_MEMORY_RANGE_ENTRY VirtualAddresses, ULONG Flags ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) HANDLE __stdcall CreateFileMappingFromApp( HANDLE hFile, PSECURITY_ATTRIBUTES SecurityAttributes, ULONG PageProtection, ULONG64 MaximumSize, PCWSTR Name ); __declspec(dllimport) PVOID __stdcall MapViewOfFileFromApp( HANDLE hFileMappingObject, ULONG DesiredAccess, ULONG64 FileOffset, SIZE_T NumberOfBytesToMap ); __declspec(dllimport) BOOL __stdcall UnmapViewOfFileEx( PVOID BaseAddress, ULONG UnmapFlags ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall AllocateUserPhysicalPages( HANDLE hProcess, PULONG_PTR NumberOfPages, PULONG_PTR PageArray ); __declspec(dllimport) BOOL __stdcall FreeUserPhysicalPages( HANDLE hProcess, PULONG_PTR NumberOfPages, PULONG_PTR PageArray ); __declspec(dllimport) BOOL __stdcall MapUserPhysicalPages( PVOID VirtualAddress, ULONG_PTR NumberOfPages, PULONG_PTR PageArray ); __declspec(dllimport) BOOL __stdcall AllocateUserPhysicalPagesNuma( HANDLE hProcess, PULONG_PTR NumberOfPages, PULONG_PTR PageArray, DWORD nndPreferred ); __declspec(dllimport) LPVOID __stdcall VirtualAllocExNuma( HANDLE hProcess, LPVOID lpAddress, SIZE_T dwSize, DWORD flAllocationType, DWORD flProtect, DWORD nndPreferred ); __declspec(dllimport) BOOL __stdcall GetMemoryErrorHandlingCapabilities( PULONG Capabilities ); typedef void __stdcall BAD_MEMORY_CALLBACK_ROUTINE( void ); typedef BAD_MEMORY_CALLBACK_ROUTINE *PBAD_MEMORY_CALLBACK_ROUTINE; __declspec(dllimport) PVOID __stdcall RegisterBadMemoryNotification( PBAD_MEMORY_CALLBACK_ROUTINE Callback ); __declspec(dllimport) BOOL __stdcall UnregisterBadMemoryNotification( PVOID RegistrationHandle ); #pragma endregion #pragma region Application Family or OneCore Family typedef enum OFFER_PRIORITY { VmOfferPriorityVeryLow = 1, VmOfferPriorityLow, VmOfferPriorityBelowNormal, VmOfferPriorityNormal } OFFER_PRIORITY; DWORD __stdcall OfferVirtualMemory( PVOID VirtualAddress, SIZE_T Size, OFFER_PRIORITY Priority ); DWORD __stdcall ReclaimVirtualMemory( void const* VirtualAddress, SIZE_T Size ); DWORD __stdcall DiscardVirtualMemory( PVOID VirtualAddress, SIZE_T Size ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetProcessValidCallTargets( HANDLE hProcess, PVOID VirtualAddress, SIZE_T RegionSize, ULONG NumberOfOffsets, PCFG_CALL_TARGET_INFO OffsetInformation ); __declspec(dllimport) PVOID __stdcall VirtualAllocFromApp( PVOID BaseAddress, SIZE_T Size, ULONG AllocationType, ULONG Protection ); __declspec(dllimport) BOOL __stdcall VirtualProtectFromApp( PVOID Address, SIZE_T Size, ULONG NewProtection, PULONG OldProtection ); __declspec(dllimport) HANDLE __stdcall OpenFileMappingFromApp( ULONG DesiredAccess, BOOL InheritHandle, PCWSTR Name ); #pragma endregion #pragma region Application Family #line 853 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\memoryapi.h" #pragma endregion #pragma region Desktop Family or OneCore Family typedef enum WIN32_MEMORY_INFORMATION_CLASS { MemoryRegionInfo } WIN32_MEMORY_INFORMATION_CLASS; #pragma warning(push) #pragma warning(disable:4201) #pragma warning(disable:4214) typedef struct WIN32_MEMORY_REGION_INFORMATION { PVOID AllocationBase; ULONG AllocationProtect; union { ULONG Flags; struct { ULONG Private : 1; ULONG MappedDataFile : 1; ULONG MappedImage : 1; ULONG MappedPageFile : 1; ULONG MappedPhysical : 1; ULONG DirectMapped : 1; ULONG Reserved : 26; } ; } ; SIZE_T RegionSize; SIZE_T CommitSize; } WIN32_MEMORY_REGION_INFORMATION; #pragma warning(pop) __declspec(dllimport) BOOL __stdcall QueryVirtualMemoryInformation( HANDLE Process, const void* VirtualAddress, WIN32_MEMORY_INFORMATION_CLASS MemoryInformationClass, PVOID MemoryInformation, SIZE_T MemoryInformationSize, PSIZE_T ReturnSize ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) PVOID __stdcall MapViewOfFileNuma2( HANDLE FileMappingHandle, HANDLE ProcessHandle, ULONG64 Offset, PVOID BaseAddress, SIZE_T ViewSize, ULONG AllocationType, ULONG PageProtection, ULONG PreferredNode ); __forceinline PVOID MapViewOfFile2( HANDLE FileMappingHandle, HANDLE ProcessHandle, ULONG64 Offset, PVOID BaseAddress, SIZE_T ViewSize, ULONG AllocationType, ULONG PageProtection ) { return MapViewOfFileNuma2(FileMappingHandle, ProcessHandle, Offset, BaseAddress, ViewSize, AllocationType, PageProtection, ((DWORD) -1)); } #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall UnmapViewOfFile2( HANDLE Process, PVOID BaseAddress, ULONG UnmapFlags ); __declspec(dllimport) BOOL __stdcall VirtualUnlockEx( HANDLE Process, LPVOID Address, SIZE_T Size ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) PVOID __stdcall VirtualAlloc2( HANDLE Process, PVOID BaseAddress, SIZE_T Size, ULONG AllocationType, ULONG PageProtection, MEM_EXTENDED_PARAMETER* ExtendedParameters, ULONG ParameterCount ); __declspec(dllimport) PVOID __stdcall MapViewOfFile3( HANDLE FileMapping, HANDLE Process, PVOID BaseAddress, ULONG64 Offset, SIZE_T ViewSize, ULONG AllocationType, ULONG PageProtection, MEM_EXTENDED_PARAMETER* ExtendedParameters, ULONG ParameterCount ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) PVOID __stdcall VirtualAlloc2FromApp( HANDLE Process, PVOID BaseAddress, SIZE_T Size, ULONG AllocationType, ULONG PageProtection, MEM_EXTENDED_PARAMETER* ExtendedParameters, ULONG ParameterCount ); __declspec(dllimport) PVOID __stdcall MapViewOfFile3FromApp( HANDLE FileMapping, HANDLE Process, PVOID BaseAddress, ULONG64 Offset, SIZE_T ViewSize, ULONG AllocationType, ULONG PageProtection, MEM_EXTENDED_PARAMETER* ExtendedParameters, ULONG ParameterCount ); #pragma endregion #pragma warning(pop) #line 57 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\enclaveapi.h" #pragma once #pragma region Desktop Family or OneCore Or App Family __declspec(dllimport) BOOL __stdcall IsEnclaveTypeSupported( DWORD flEnclaveType ); __declspec(dllimport) LPVOID __stdcall CreateEnclave( HANDLE hProcess, LPVOID lpAddress, SIZE_T dwSize, SIZE_T dwInitialCommitment, DWORD flEnclaveType, LPCVOID lpEnclaveInformation, DWORD dwInfoLength, LPDWORD lpEnclaveError ); __declspec(dllimport) BOOL __stdcall LoadEnclaveData( HANDLE hProcess, LPVOID lpAddress, LPCVOID lpBuffer, SIZE_T nSize, DWORD flProtect, LPCVOID lpPageInformation, DWORD dwInfoLength, PSIZE_T lpNumberOfBytesWritten, LPDWORD lpEnclaveError ); __declspec(dllimport) BOOL __stdcall InitializeEnclave( HANDLE hProcess, LPVOID lpAddress, LPCVOID lpEnclaveInformation, DWORD dwInfoLength, LPDWORD lpEnclaveError ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall LoadEnclaveImageA( LPVOID lpEnclaveAddress, LPCSTR lpImageName ); __declspec(dllimport) BOOL __stdcall LoadEnclaveImageW( LPVOID lpEnclaveAddress, LPCWSTR lpImageName ); __declspec(dllimport) BOOL __stdcall CallEnclave( LPENCLAVE_ROUTINE lpRoutine, LPVOID lpParameter, BOOL fWaitForThread, LPVOID* lpReturnValue ); __declspec(dllimport) BOOL __stdcall TerminateEnclave( LPVOID lpAddress, BOOL fWait ); __declspec(dllimport) BOOL __stdcall DeleteEnclave( LPVOID lpAddress ); #pragma endregion #line 58 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\threadpoollegacyapiset.h" #pragma once #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall QueueUserWorkItem( LPTHREAD_START_ROUTINE Function, PVOID Context, ULONG Flags ); __declspec(dllimport) BOOL __stdcall UnregisterWaitEx( HANDLE WaitHandle, HANDLE CompletionEvent ); __declspec(dllimport) HANDLE __stdcall CreateTimerQueue( void ); __declspec(dllimport) BOOL __stdcall CreateTimerQueueTimer( PHANDLE phNewTimer, HANDLE TimerQueue, WAITORTIMERCALLBACK Callback, PVOID Parameter, DWORD DueTime, DWORD Period, ULONG Flags ); __declspec(dllimport) BOOL __stdcall ChangeTimerQueueTimer( HANDLE TimerQueue, HANDLE Timer, ULONG DueTime, ULONG Period ); __declspec(dllimport) BOOL __stdcall DeleteTimerQueueTimer( HANDLE TimerQueue, HANDLE Timer, HANDLE CompletionEvent ); __declspec(dllimport) BOOL __stdcall DeleteTimerQueueEx( HANDLE TimerQueue, HANDLE CompletionEvent ); #pragma endregion #line 59 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\threadpoolapiset.h" #pragma once #pragma region Application Family or OneCore Family typedef void (__stdcall *PTP_WIN32_IO_CALLBACK)( PTP_CALLBACK_INSTANCE Instance, PVOID Context, PVOID Overlapped, ULONG IoResult, ULONG_PTR NumberOfBytesTransferred, PTP_IO Io ); __declspec(dllimport) PTP_POOL __stdcall CreateThreadpool( PVOID reserved ); __declspec(dllimport) void __stdcall SetThreadpoolThreadMaximum( PTP_POOL ptpp, DWORD cthrdMost ); __declspec(dllimport) BOOL __stdcall SetThreadpoolThreadMinimum( PTP_POOL ptpp, DWORD cthrdMic ); __declspec(dllimport) BOOL __stdcall SetThreadpoolStackInformation( PTP_POOL ptpp, PTP_POOL_STACK_INFORMATION ptpsi ); __declspec(dllimport) BOOL __stdcall QueryThreadpoolStackInformation( PTP_POOL ptpp, PTP_POOL_STACK_INFORMATION ptpsi ); __declspec(dllimport) void __stdcall CloseThreadpool( PTP_POOL ptpp ); __declspec(dllimport) PTP_CLEANUP_GROUP __stdcall CreateThreadpoolCleanupGroup( void ); __declspec(dllimport) void __stdcall CloseThreadpoolCleanupGroupMembers( PTP_CLEANUP_GROUP ptpcg, BOOL fCancelPendingCallbacks, PVOID pvCleanupContext ); __declspec(dllimport) void __stdcall CloseThreadpoolCleanupGroup( PTP_CLEANUP_GROUP ptpcg ); __declspec(dllimport) void __stdcall SetEventWhenCallbackReturns( PTP_CALLBACK_INSTANCE pci, HANDLE evt ); __declspec(dllimport) void __stdcall ReleaseSemaphoreWhenCallbackReturns( PTP_CALLBACK_INSTANCE pci, HANDLE sem, DWORD crel ); __declspec(dllimport) void __stdcall ReleaseMutexWhenCallbackReturns( PTP_CALLBACK_INSTANCE pci, HANDLE mut ); __declspec(dllimport) void __stdcall LeaveCriticalSectionWhenCallbackReturns( PTP_CALLBACK_INSTANCE pci, PCRITICAL_SECTION pcs ); __declspec(dllimport) void __stdcall FreeLibraryWhenCallbackReturns( PTP_CALLBACK_INSTANCE pci, HMODULE mod ); __declspec(dllimport) BOOL __stdcall CallbackMayRunLong( PTP_CALLBACK_INSTANCE pci ); __declspec(dllimport) void __stdcall DisassociateCurrentThreadFromCallback( PTP_CALLBACK_INSTANCE pci ); __declspec(dllimport) BOOL __stdcall TrySubmitThreadpoolCallback( PTP_SIMPLE_CALLBACK pfns, PVOID pv, PTP_CALLBACK_ENVIRON pcbe ); __declspec(dllimport) PTP_WORK __stdcall CreateThreadpoolWork( PTP_WORK_CALLBACK pfnwk, PVOID pv, PTP_CALLBACK_ENVIRON pcbe ); __declspec(dllimport) void __stdcall SubmitThreadpoolWork( PTP_WORK pwk ); __declspec(dllimport) void __stdcall WaitForThreadpoolWorkCallbacks( PTP_WORK pwk, BOOL fCancelPendingCallbacks ); __declspec(dllimport) void __stdcall CloseThreadpoolWork( PTP_WORK pwk ); __declspec(dllimport) PTP_TIMER __stdcall CreateThreadpoolTimer( PTP_TIMER_CALLBACK pfnti, PVOID pv, PTP_CALLBACK_ENVIRON pcbe ); __declspec(dllimport) void __stdcall SetThreadpoolTimer( PTP_TIMER pti, PFILETIME pftDueTime, DWORD msPeriod, DWORD msWindowLength ); __declspec(dllimport) BOOL __stdcall IsThreadpoolTimerSet( PTP_TIMER pti ); __declspec(dllimport) void __stdcall WaitForThreadpoolTimerCallbacks( PTP_TIMER pti, BOOL fCancelPendingCallbacks ); __declspec(dllimport) void __stdcall CloseThreadpoolTimer( PTP_TIMER pti ); __declspec(dllimport) PTP_WAIT __stdcall CreateThreadpoolWait( PTP_WAIT_CALLBACK pfnwa, PVOID pv, PTP_CALLBACK_ENVIRON pcbe ); __declspec(dllimport) void __stdcall SetThreadpoolWait( PTP_WAIT pwa, HANDLE h, PFILETIME pftTimeout ); __declspec(dllimport) void __stdcall WaitForThreadpoolWaitCallbacks( PTP_WAIT pwa, BOOL fCancelPendingCallbacks ); __declspec(dllimport) void __stdcall CloseThreadpoolWait( PTP_WAIT pwa ); __declspec(dllimport) PTP_IO __stdcall CreateThreadpoolIo( HANDLE fl, PTP_WIN32_IO_CALLBACK pfnio, PVOID pv, PTP_CALLBACK_ENVIRON pcbe ); __declspec(dllimport) void __stdcall StartThreadpoolIo( PTP_IO pio ); __declspec(dllimport) void __stdcall CancelThreadpoolIo( PTP_IO pio ); __declspec(dllimport) void __stdcall WaitForThreadpoolIoCallbacks( PTP_IO pio, BOOL fCancelPendingCallbacks ); __declspec(dllimport) void __stdcall CloseThreadpoolIo( PTP_IO pio ); __declspec(dllimport) BOOL __stdcall SetThreadpoolTimerEx( PTP_TIMER pti, PFILETIME pftDueTime, DWORD msPeriod, DWORD msWindowLength ); __declspec(dllimport) BOOL __stdcall SetThreadpoolWaitEx( PTP_WAIT pwa, HANDLE h, PFILETIME pftTimeout, PVOID Reserved ); #pragma endregion #pragma region Desktop Family or OneCore Family #pragma endregion #line 60 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\jobapi.h" #pragma once #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall IsProcessInJob( HANDLE ProcessHandle, HANDLE JobHandle, PBOOL Result ); #pragma endregion #line 61 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\jobapi2.h" #pragma once #pragma region Desktop Family or OneCore Family typedef struct JOBOBJECT_IO_RATE_CONTROL_INFORMATION { LONG64 MaxIops; LONG64 MaxBandwidth; LONG64 ReservationIops; PCWSTR VolumeName; ULONG BaseIoSize; ULONG ControlFlags; } JOBOBJECT_IO_RATE_CONTROL_INFORMATION; __declspec(dllimport) HANDLE __stdcall CreateJobObjectW( LPSECURITY_ATTRIBUTES lpJobAttributes, LPCWSTR lpName ); __declspec(dllimport) void __stdcall FreeMemoryJobObject( void* Buffer ); __declspec(dllimport) HANDLE __stdcall OpenJobObjectW( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCWSTR lpName ); __declspec(dllimport) BOOL __stdcall AssignProcessToJobObject( HANDLE hJob, HANDLE hProcess ); __declspec(dllimport) BOOL __stdcall TerminateJobObject( HANDLE hJob, UINT uExitCode ); __declspec(dllimport) BOOL __stdcall SetInformationJobObject( HANDLE hJob, JOBOBJECTINFOCLASS JobObjectInformationClass, LPVOID lpJobObjectInformation, DWORD cbJobObjectInformationLength ); __declspec(dllimport) DWORD __stdcall SetIoRateControlInformationJobObject( HANDLE hJob, JOBOBJECT_IO_RATE_CONTROL_INFORMATION* IoRateControlInfo ); __declspec(dllimport) BOOL __stdcall QueryInformationJobObject( HANDLE hJob, JOBOBJECTINFOCLASS JobObjectInformationClass, LPVOID lpJobObjectInformation, DWORD cbJobObjectInformationLength, LPDWORD lpReturnLength ); __declspec(dllimport) DWORD __stdcall QueryIoRateControlInformationJobObject( HANDLE hJob, PCWSTR VolumeName, JOBOBJECT_IO_RATE_CONTROL_INFORMATION** InfoBlocks, ULONG* InfoBlockCount ); #pragma endregion #line 62 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\wow64apiset.h" #pragma once #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall Wow64DisableWow64FsRedirection( PVOID* OldValue ); __declspec(dllimport) BOOL __stdcall Wow64RevertWow64FsRedirection( PVOID OlValue ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall IsWow64Process( HANDLE hProcess, PBOOL Wow64Process ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) UINT __stdcall GetSystemWow64DirectoryA( LPSTR lpBuffer, UINT uSize ); __declspec(dllimport) UINT __stdcall GetSystemWow64DirectoryW( LPWSTR lpBuffer, UINT uSize ); __declspec(dllimport) USHORT __stdcall Wow64SetThreadDefaultGuestMachine( USHORT Machine ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall IsWow64Process2( HANDLE hProcess, USHORT* pProcessMachine, USHORT* pNativeMachine ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) UINT __stdcall GetSystemWow64Directory2A( LPSTR lpBuffer, UINT uSize, WORD ImageFileMachineType ); __declspec(dllimport) UINT __stdcall GetSystemWow64Directory2W( LPWSTR lpBuffer, UINT uSize, WORD ImageFileMachineType ); __declspec(dllimport) HRESULT __stdcall IsWow64GuestMachineSupported( USHORT WowGuestMachine, BOOL* MachineIsSupported ); #pragma endregion #line 63 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\libloaderapi.h" #pragma once #pragma region Desktop Family or OneCore Family typedef struct tagENUMUILANG { ULONG NumOfEnumUILang; ULONG SizeOfEnumUIBuffer; LANGID *pEnumUIBuffer; } ENUMUILANG, *PENUMUILANG; typedef BOOL (__stdcall* ENUMRESLANGPROCA)( HMODULE hModule, LPCSTR lpType, LPCSTR lpName, WORD wLanguage, LONG_PTR lParam); typedef BOOL (__stdcall* ENUMRESLANGPROCW)( HMODULE hModule, LPCWSTR lpType, LPCWSTR lpName, WORD wLanguage, LONG_PTR lParam); typedef BOOL (__stdcall* ENUMRESNAMEPROCA)( HMODULE hModule, LPCSTR lpType, LPSTR lpName, LONG_PTR lParam); typedef BOOL (__stdcall* ENUMRESNAMEPROCW)( HMODULE hModule, LPCWSTR lpType, LPWSTR lpName, LONG_PTR lParam); typedef BOOL (__stdcall* ENUMRESTYPEPROCA)( HMODULE hModule, LPSTR lpType, LONG_PTR lParam ); typedef BOOL (__stdcall* ENUMRESTYPEPROCW)( HMODULE hModule, LPWSTR lpType, LONG_PTR lParam ); #line 123 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\libloaderapi.h" #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall DisableThreadLibraryCalls( HMODULE hLibModule ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HRSRC __stdcall FindResourceExW( HMODULE hModule, LPCWSTR lpType, LPCWSTR lpName, WORD wLanguage ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) int __stdcall FindStringOrdinal( DWORD dwFindStringOrdinalFlags, LPCWSTR lpStringSource, int cchSource, LPCWSTR lpStringValue, int cchValue, BOOL bIgnoreCase ); __declspec(dllimport) BOOL __stdcall FreeLibrary( HMODULE hLibModule ); __declspec(dllimport) __declspec(noreturn) void __stdcall FreeLibraryAndExitThread( HMODULE hLibModule, DWORD dwExitCode ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall FreeResource( HGLOBAL hResData ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetModuleFileNameA( HMODULE hModule, LPSTR lpFilename, DWORD nSize ); __declspec(dllimport) DWORD __stdcall GetModuleFileNameW( HMODULE hModule, LPWSTR lpFilename, DWORD nSize ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HMODULE __stdcall GetModuleHandleA( LPCSTR lpModuleName ); __declspec(dllimport) HMODULE __stdcall GetModuleHandleW( LPCWSTR lpModuleName ); typedef BOOL (__stdcall* PGET_MODULE_HANDLE_EXA)( DWORD dwFlags, LPCSTR lpModuleName, HMODULE* phModule ); typedef BOOL (__stdcall* PGET_MODULE_HANDLE_EXW)( DWORD dwFlags, LPCWSTR lpModuleName, HMODULE* phModule ); __declspec(dllimport) BOOL __stdcall GetModuleHandleExA( DWORD dwFlags, LPCSTR lpModuleName, HMODULE* phModule ); __declspec(dllimport) BOOL __stdcall GetModuleHandleExW( DWORD dwFlags, LPCWSTR lpModuleName, HMODULE* phModule ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) FARPROC __stdcall GetProcAddress( HMODULE hModule, LPCSTR lpProcName ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HMODULE __stdcall LoadLibraryExA( LPCSTR lpLibFileName, HANDLE hFile, DWORD dwFlags ); __declspec(dllimport) HMODULE __stdcall LoadLibraryExW( LPCWSTR lpLibFileName, HANDLE hFile, DWORD dwFlags ); #line 393 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\libloaderapi.h" #line 410 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\libloaderapi.h" __declspec(dllimport) HGLOBAL __stdcall LoadResource( HMODULE hModule, HRSRC hResInfo ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) int __stdcall LoadStringA( HINSTANCE hInstance, UINT uID, LPSTR lpBuffer, int cchBufferMax ); __declspec(dllimport) int __stdcall LoadStringW( HINSTANCE hInstance, UINT uID, LPWSTR lpBuffer, int cchBufferMax ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) LPVOID __stdcall LockResource( HGLOBAL hResData ); __declspec(dllimport) DWORD __stdcall SizeofResource( HMODULE hModule, HRSRC hResInfo ); #pragma endregion #pragma region Desktop Family or OneCore Family typedef PVOID DLL_DIRECTORY_COOKIE, *PDLL_DIRECTORY_COOKIE; __declspec(dllimport) DLL_DIRECTORY_COOKIE __stdcall AddDllDirectory( PCWSTR NewDirectory ); __declspec(dllimport) BOOL __stdcall RemoveDllDirectory( DLL_DIRECTORY_COOKIE Cookie ); __declspec(dllimport) BOOL __stdcall SetDefaultDllDirectories( DWORD DirectoryFlags ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall EnumResourceLanguagesExA( HMODULE hModule, LPCSTR lpType, LPCSTR lpName, ENUMRESLANGPROCA lpEnumFunc, LONG_PTR lParam, DWORD dwFlags, LANGID LangId ); __declspec(dllimport) BOOL __stdcall EnumResourceLanguagesExW( HMODULE hModule, LPCWSTR lpType, LPCWSTR lpName, ENUMRESLANGPROCW lpEnumFunc, LONG_PTR lParam, DWORD dwFlags, LANGID LangId ); __declspec(dllimport) BOOL __stdcall EnumResourceNamesExA( HMODULE hModule, LPCSTR lpType, ENUMRESNAMEPROCA lpEnumFunc, LONG_PTR lParam, DWORD dwFlags, LANGID LangId ); __declspec(dllimport) BOOL __stdcall EnumResourceNamesExW( HMODULE hModule, LPCWSTR lpType, ENUMRESNAMEPROCW lpEnumFunc, LONG_PTR lParam, DWORD dwFlags, LANGID LangId ); __declspec(dllimport) BOOL __stdcall EnumResourceTypesExA( HMODULE hModule, ENUMRESTYPEPROCA lpEnumFunc, LONG_PTR lParam, DWORD dwFlags, LANGID LangId ); __declspec(dllimport) BOOL __stdcall EnumResourceTypesExW( HMODULE hModule, ENUMRESTYPEPROCW lpEnumFunc, LONG_PTR lParam, DWORD dwFlags, LANGID LangId ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HRSRC __stdcall FindResourceW( HMODULE hModule, LPCWSTR lpName, LPCWSTR lpType ); __declspec(dllimport) HMODULE __stdcall LoadLibraryA( LPCSTR lpLibFileName ); __declspec(dllimport) HMODULE __stdcall LoadLibraryW( LPCWSTR lpLibFileName ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall EnumResourceNamesW( HMODULE hModule, LPCWSTR lpType, ENUMRESNAMEPROCW lpEnumFunc, LONG_PTR lParam ); #pragma endregion #line 64 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\securitybaseapi.h" #pragma once #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall AccessCheck( PSECURITY_DESCRIPTOR pSecurityDescriptor, HANDLE ClientToken, DWORD DesiredAccess, PGENERIC_MAPPING GenericMapping, PPRIVILEGE_SET PrivilegeSet, LPDWORD PrivilegeSetLength, LPDWORD GrantedAccess, LPBOOL AccessStatus ); __declspec(dllimport) BOOL __stdcall AccessCheckAndAuditAlarmW( LPCWSTR SubsystemName, LPVOID HandleId, LPWSTR ObjectTypeName, LPWSTR ObjectName, PSECURITY_DESCRIPTOR SecurityDescriptor, DWORD DesiredAccess, PGENERIC_MAPPING GenericMapping, BOOL ObjectCreation, LPDWORD GrantedAccess, LPBOOL AccessStatus, LPBOOL pfGenerateOnClose ); __declspec(dllimport) BOOL __stdcall AccessCheckByType( PSECURITY_DESCRIPTOR pSecurityDescriptor, PSID PrincipalSelfSid, HANDLE ClientToken, DWORD DesiredAccess, POBJECT_TYPE_LIST ObjectTypeList, DWORD ObjectTypeListLength, PGENERIC_MAPPING GenericMapping, PPRIVILEGE_SET PrivilegeSet, LPDWORD PrivilegeSetLength, LPDWORD GrantedAccess, LPBOOL AccessStatus ); __declspec(dllimport) BOOL __stdcall AccessCheckByTypeResultList( PSECURITY_DESCRIPTOR pSecurityDescriptor, PSID PrincipalSelfSid, HANDLE ClientToken, DWORD DesiredAccess, POBJECT_TYPE_LIST ObjectTypeList, DWORD ObjectTypeListLength, PGENERIC_MAPPING GenericMapping, PPRIVILEGE_SET PrivilegeSet, LPDWORD PrivilegeSetLength, LPDWORD GrantedAccessList, LPDWORD AccessStatusList ); __declspec(dllimport) BOOL __stdcall AccessCheckByTypeAndAuditAlarmW( LPCWSTR SubsystemName, LPVOID HandleId, LPCWSTR ObjectTypeName, LPCWSTR ObjectName, PSECURITY_DESCRIPTOR SecurityDescriptor, PSID PrincipalSelfSid, DWORD DesiredAccess, AUDIT_EVENT_TYPE AuditType, DWORD Flags, POBJECT_TYPE_LIST ObjectTypeList, DWORD ObjectTypeListLength, PGENERIC_MAPPING GenericMapping, BOOL ObjectCreation, LPDWORD GrantedAccess, LPBOOL AccessStatus, LPBOOL pfGenerateOnClose ); __declspec(dllimport) BOOL __stdcall AccessCheckByTypeResultListAndAuditAlarmW( LPCWSTR SubsystemName, LPVOID HandleId, LPCWSTR ObjectTypeName, LPCWSTR ObjectName, PSECURITY_DESCRIPTOR SecurityDescriptor, PSID PrincipalSelfSid, DWORD DesiredAccess, AUDIT_EVENT_TYPE AuditType, DWORD Flags, POBJECT_TYPE_LIST ObjectTypeList, DWORD ObjectTypeListLength, PGENERIC_MAPPING GenericMapping, BOOL ObjectCreation, LPDWORD GrantedAccessList, LPDWORD AccessStatusList, LPBOOL pfGenerateOnClose ); __declspec(dllimport) BOOL __stdcall AccessCheckByTypeResultListAndAuditAlarmByHandleW( LPCWSTR SubsystemName, LPVOID HandleId, HANDLE ClientToken, LPCWSTR ObjectTypeName, LPCWSTR ObjectName, PSECURITY_DESCRIPTOR SecurityDescriptor, PSID PrincipalSelfSid, DWORD DesiredAccess, AUDIT_EVENT_TYPE AuditType, DWORD Flags, POBJECT_TYPE_LIST ObjectTypeList, DWORD ObjectTypeListLength, PGENERIC_MAPPING GenericMapping, BOOL ObjectCreation, LPDWORD GrantedAccessList, LPDWORD AccessStatusList, LPBOOL pfGenerateOnClose ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall AddAccessAllowedAce( PACL pAcl, DWORD dwAceRevision, DWORD AccessMask, PSID pSid ); __declspec(dllimport) BOOL __stdcall AddAccessAllowedAceEx( PACL pAcl, DWORD dwAceRevision, DWORD AceFlags, DWORD AccessMask, PSID pSid ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall AddAccessAllowedObjectAce( PACL pAcl, DWORD dwAceRevision, DWORD AceFlags, DWORD AccessMask, GUID* ObjectTypeGuid, GUID* InheritedObjectTypeGuid, PSID pSid ); __declspec(dllimport) BOOL __stdcall AddAccessDeniedAce( PACL pAcl, DWORD dwAceRevision, DWORD AccessMask, PSID pSid ); __declspec(dllimport) BOOL __stdcall AddAccessDeniedAceEx( PACL pAcl, DWORD dwAceRevision, DWORD AceFlags, DWORD AccessMask, PSID pSid ); __declspec(dllimport) BOOL __stdcall AddAccessDeniedObjectAce( PACL pAcl, DWORD dwAceRevision, DWORD AceFlags, DWORD AccessMask, GUID* ObjectTypeGuid, GUID* InheritedObjectTypeGuid, PSID pSid ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall AddAce( PACL pAcl, DWORD dwAceRevision, DWORD dwStartingAceIndex, LPVOID pAceList, DWORD nAceListLength ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall AddAuditAccessAce( PACL pAcl, DWORD dwAceRevision, DWORD dwAccessMask, PSID pSid, BOOL bAuditSuccess, BOOL bAuditFailure ); __declspec(dllimport) BOOL __stdcall AddAuditAccessAceEx( PACL pAcl, DWORD dwAceRevision, DWORD AceFlags, DWORD dwAccessMask, PSID pSid, BOOL bAuditSuccess, BOOL bAuditFailure ); __declspec(dllimport) BOOL __stdcall AddAuditAccessObjectAce( PACL pAcl, DWORD dwAceRevision, DWORD AceFlags, DWORD AccessMask, GUID* ObjectTypeGuid, GUID* InheritedObjectTypeGuid, PSID pSid, BOOL bAuditSuccess, BOOL bAuditFailure ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall AddMandatoryAce( PACL pAcl, DWORD dwAceRevision, DWORD AceFlags, DWORD MandatoryPolicy, PSID pLabelSid ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall AddResourceAttributeAce( PACL pAcl, DWORD dwAceRevision, DWORD AceFlags, DWORD AccessMask, PSID pSid, PCLAIM_SECURITY_ATTRIBUTES_INFORMATION pAttributeInfo, PDWORD pReturnLength ); __declspec(dllimport) BOOL __stdcall AddScopedPolicyIDAce( PACL pAcl, DWORD dwAceRevision, DWORD AceFlags, DWORD AccessMask, PSID pSid ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall AdjustTokenGroups( HANDLE TokenHandle, BOOL ResetToDefault, PTOKEN_GROUPS NewState, DWORD BufferLength, PTOKEN_GROUPS PreviousState, PDWORD ReturnLength ); __declspec(dllimport) BOOL __stdcall AdjustTokenPrivileges( HANDLE TokenHandle, BOOL DisableAllPrivileges, PTOKEN_PRIVILEGES NewState, DWORD BufferLength, PTOKEN_PRIVILEGES PreviousState, PDWORD ReturnLength ); __declspec(dllimport) BOOL __stdcall AllocateAndInitializeSid( PSID_IDENTIFIER_AUTHORITY pIdentifierAuthority, BYTE nSubAuthorityCount, DWORD nSubAuthority0, DWORD nSubAuthority1, DWORD nSubAuthority2, DWORD nSubAuthority3, DWORD nSubAuthority4, DWORD nSubAuthority5, DWORD nSubAuthority6, DWORD nSubAuthority7, PSID* pSid ); __declspec(dllimport) BOOL __stdcall AllocateLocallyUniqueId( PLUID Luid ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall AreAllAccessesGranted( DWORD GrantedAccess, DWORD DesiredAccess ); __declspec(dllimport) BOOL __stdcall AreAnyAccessesGranted( DWORD GrantedAccess, DWORD DesiredAccess ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall CheckTokenMembership( HANDLE TokenHandle, PSID SidToCheck, PBOOL IsMember ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall CheckTokenCapability( HANDLE TokenHandle, PSID CapabilitySidToCheck, PBOOL HasCapability ); __declspec(dllimport) BOOL __stdcall GetAppContainerAce( PACL Acl, DWORD StartingAceIndex, PVOID* AppContainerAce, DWORD* AppContainerAceIndex ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall CheckTokenMembershipEx( HANDLE TokenHandle, PSID SidToCheck, DWORD Flags, PBOOL IsMember ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall ConvertToAutoInheritPrivateObjectSecurity( PSECURITY_DESCRIPTOR ParentDescriptor, PSECURITY_DESCRIPTOR CurrentSecurityDescriptor, PSECURITY_DESCRIPTOR* NewSecurityDescriptor, GUID* ObjectType, BOOLEAN IsDirectoryObject, PGENERIC_MAPPING GenericMapping ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall CopySid( DWORD nDestinationSidLength, PSID pDestinationSid, PSID pSourceSid ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall CreatePrivateObjectSecurity( PSECURITY_DESCRIPTOR ParentDescriptor, PSECURITY_DESCRIPTOR CreatorDescriptor, PSECURITY_DESCRIPTOR* NewDescriptor, BOOL IsDirectoryObject, HANDLE Token, PGENERIC_MAPPING GenericMapping ); __declspec(dllimport) BOOL __stdcall CreatePrivateObjectSecurityEx( PSECURITY_DESCRIPTOR ParentDescriptor, PSECURITY_DESCRIPTOR CreatorDescriptor, PSECURITY_DESCRIPTOR* NewDescriptor, GUID* ObjectType, BOOL IsContainerObject, ULONG AutoInheritFlags, HANDLE Token, PGENERIC_MAPPING GenericMapping ); __declspec(dllimport) BOOL __stdcall CreatePrivateObjectSecurityWithMultipleInheritance( PSECURITY_DESCRIPTOR ParentDescriptor, PSECURITY_DESCRIPTOR CreatorDescriptor, PSECURITY_DESCRIPTOR* NewDescriptor, GUID** ObjectTypes, ULONG GuidCount, BOOL IsContainerObject, ULONG AutoInheritFlags, HANDLE Token, PGENERIC_MAPPING GenericMapping ); __declspec(dllimport) BOOL __stdcall CreateRestrictedToken( HANDLE ExistingTokenHandle, DWORD Flags, DWORD DisableSidCount, PSID_AND_ATTRIBUTES SidsToDisable, DWORD DeletePrivilegeCount, PLUID_AND_ATTRIBUTES PrivilegesToDelete, DWORD RestrictedSidCount, PSID_AND_ATTRIBUTES SidsToRestrict, PHANDLE NewTokenHandle ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall CreateWellKnownSid( WELL_KNOWN_SID_TYPE WellKnownSidType, PSID DomainSid, PSID pSid, DWORD* cbSid ); __declspec(dllimport) BOOL __stdcall EqualDomainSid( PSID pSid1, PSID pSid2, BOOL* pfEqual ); __declspec(dllimport) BOOL __stdcall DeleteAce( PACL pAcl, DWORD dwAceIndex ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall DestroyPrivateObjectSecurity( PSECURITY_DESCRIPTOR* ObjectDescriptor ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall DuplicateToken( HANDLE ExistingTokenHandle, SECURITY_IMPERSONATION_LEVEL ImpersonationLevel, PHANDLE DuplicateTokenHandle ); __declspec(dllimport) BOOL __stdcall DuplicateTokenEx( HANDLE hExistingToken, DWORD dwDesiredAccess, LPSECURITY_ATTRIBUTES lpTokenAttributes, SECURITY_IMPERSONATION_LEVEL ImpersonationLevel, TOKEN_TYPE TokenType, PHANDLE phNewToken ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall EqualPrefixSid( PSID pSid1, PSID pSid2 ); __declspec(dllimport) BOOL __stdcall EqualSid( PSID pSid1, PSID pSid2 ); __declspec(dllimport) BOOL __stdcall FindFirstFreeAce( PACL pAcl, LPVOID* pAce ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) PVOID __stdcall FreeSid( PSID pSid ); __declspec(dllimport) BOOL __stdcall GetAce( PACL pAcl, DWORD dwAceIndex, LPVOID* pAce ); __declspec(dllimport) BOOL __stdcall GetAclInformation( PACL pAcl, LPVOID pAclInformation, DWORD nAclInformationLength, ACL_INFORMATION_CLASS dwAclInformationClass ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetFileSecurityW( LPCWSTR lpFileName, SECURITY_INFORMATION RequestedInformation, PSECURITY_DESCRIPTOR pSecurityDescriptor, DWORD nLength, LPDWORD lpnLengthNeeded ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetKernelObjectSecurity( HANDLE Handle, SECURITY_INFORMATION RequestedInformation, PSECURITY_DESCRIPTOR pSecurityDescriptor, DWORD nLength, LPDWORD lpnLengthNeeded ); __declspec(dllimport) DWORD __stdcall GetLengthSid( PSID pSid ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetPrivateObjectSecurity( PSECURITY_DESCRIPTOR ObjectDescriptor, SECURITY_INFORMATION SecurityInformation, PSECURITY_DESCRIPTOR ResultantDescriptor, DWORD DescriptorLength, PDWORD ReturnLength ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetSecurityDescriptorControl( PSECURITY_DESCRIPTOR pSecurityDescriptor, PSECURITY_DESCRIPTOR_CONTROL pControl, LPDWORD lpdwRevision ); __declspec(dllimport) BOOL __stdcall GetSecurityDescriptorDacl( PSECURITY_DESCRIPTOR pSecurityDescriptor, LPBOOL lpbDaclPresent, PACL* pDacl, LPBOOL lpbDaclDefaulted ); __declspec(dllimport) BOOL __stdcall GetSecurityDescriptorGroup( PSECURITY_DESCRIPTOR pSecurityDescriptor, PSID* pGroup, LPBOOL lpbGroupDefaulted ); __declspec(dllimport) DWORD __stdcall GetSecurityDescriptorLength( PSECURITY_DESCRIPTOR pSecurityDescriptor ); __declspec(dllimport) BOOL __stdcall GetSecurityDescriptorOwner( PSECURITY_DESCRIPTOR pSecurityDescriptor, PSID* pOwner, LPBOOL lpbOwnerDefaulted ); __declspec(dllimport) DWORD __stdcall GetSecurityDescriptorRMControl( PSECURITY_DESCRIPTOR SecurityDescriptor, PUCHAR RMControl ); __declspec(dllimport) BOOL __stdcall GetSecurityDescriptorSacl( PSECURITY_DESCRIPTOR pSecurityDescriptor, LPBOOL lpbSaclPresent, PACL* pSacl, LPBOOL lpbSaclDefaulted ); __declspec(dllimport) PSID_IDENTIFIER_AUTHORITY __stdcall GetSidIdentifierAuthority( PSID pSid ); __declspec(dllimport) DWORD __stdcall GetSidLengthRequired( UCHAR nSubAuthorityCount ); __declspec(dllimport) PDWORD __stdcall GetSidSubAuthority( PSID pSid, DWORD nSubAuthority ); __declspec(dllimport) PUCHAR __stdcall GetSidSubAuthorityCount( PSID pSid ); __declspec(dllimport) BOOL __stdcall GetTokenInformation( HANDLE TokenHandle, TOKEN_INFORMATION_CLASS TokenInformationClass, LPVOID TokenInformation, DWORD TokenInformationLength, PDWORD ReturnLength ); __declspec(dllimport) BOOL __stdcall GetWindowsAccountDomainSid( PSID pSid, PSID pDomainSid, DWORD* cbDomainSid ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall ImpersonateAnonymousToken( HANDLE ThreadHandle ); __declspec(dllimport) BOOL __stdcall ImpersonateLoggedOnUser( HANDLE hToken ); __declspec(dllimport) BOOL __stdcall ImpersonateSelf( SECURITY_IMPERSONATION_LEVEL ImpersonationLevel ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall InitializeAcl( PACL pAcl, DWORD nAclLength, DWORD dwAclRevision ); __declspec(dllimport) BOOL __stdcall InitializeSecurityDescriptor( PSECURITY_DESCRIPTOR pSecurityDescriptor, DWORD dwRevision ); __declspec(dllimport) BOOL __stdcall InitializeSid( PSID Sid, PSID_IDENTIFIER_AUTHORITY pIdentifierAuthority, BYTE nSubAuthorityCount ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall IsTokenRestricted( HANDLE TokenHandle ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall IsValidAcl( PACL pAcl ); __declspec(dllimport) BOOL __stdcall IsValidSecurityDescriptor( PSECURITY_DESCRIPTOR pSecurityDescriptor ); __declspec(dllimport) BOOL __stdcall IsValidSid( PSID pSid ); __declspec(dllimport) BOOL __stdcall IsWellKnownSid( PSID pSid, WELL_KNOWN_SID_TYPE WellKnownSidType ); __declspec(dllimport) BOOL __stdcall MakeAbsoluteSD( PSECURITY_DESCRIPTOR pSelfRelativeSecurityDescriptor, PSECURITY_DESCRIPTOR pAbsoluteSecurityDescriptor, LPDWORD lpdwAbsoluteSecurityDescriptorSize, PACL pDacl, LPDWORD lpdwDaclSize, PACL pSacl, LPDWORD lpdwSaclSize, PSID pOwner, LPDWORD lpdwOwnerSize, PSID pPrimaryGroup, LPDWORD lpdwPrimaryGroupSize ); __declspec(dllimport) BOOL __stdcall MakeSelfRelativeSD( PSECURITY_DESCRIPTOR pAbsoluteSecurityDescriptor, PSECURITY_DESCRIPTOR pSelfRelativeSecurityDescriptor, LPDWORD lpdwBufferLength ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) void __stdcall MapGenericMask( PDWORD AccessMask, PGENERIC_MAPPING GenericMapping ); __declspec(dllimport) BOOL __stdcall ObjectCloseAuditAlarmW( LPCWSTR SubsystemName, LPVOID HandleId, BOOL GenerateOnClose ); __declspec(dllimport) BOOL __stdcall ObjectDeleteAuditAlarmW( LPCWSTR SubsystemName, LPVOID HandleId, BOOL GenerateOnClose ); __declspec(dllimport) BOOL __stdcall ObjectOpenAuditAlarmW( LPCWSTR SubsystemName, LPVOID HandleId, LPWSTR ObjectTypeName, LPWSTR ObjectName, PSECURITY_DESCRIPTOR pSecurityDescriptor, HANDLE ClientToken, DWORD DesiredAccess, DWORD GrantedAccess, PPRIVILEGE_SET Privileges, BOOL ObjectCreation, BOOL AccessGranted, LPBOOL GenerateOnClose ); __declspec(dllimport) BOOL __stdcall ObjectPrivilegeAuditAlarmW( LPCWSTR SubsystemName, LPVOID HandleId, HANDLE ClientToken, DWORD DesiredAccess, PPRIVILEGE_SET Privileges, BOOL AccessGranted ); __declspec(dllimport) BOOL __stdcall PrivilegeCheck( HANDLE ClientToken, PPRIVILEGE_SET RequiredPrivileges, LPBOOL pfResult ); __declspec(dllimport) BOOL __stdcall PrivilegedServiceAuditAlarmW( LPCWSTR SubsystemName, LPCWSTR ServiceName, HANDLE ClientToken, PPRIVILEGE_SET Privileges, BOOL AccessGranted ); __declspec(dllimport) void __stdcall QuerySecurityAccessMask( SECURITY_INFORMATION SecurityInformation, LPDWORD DesiredAccess ); __declspec(dllimport) BOOL __stdcall RevertToSelf( void ); __declspec(dllimport) BOOL __stdcall SetAclInformation( PACL pAcl, LPVOID pAclInformation, DWORD nAclInformationLength, ACL_INFORMATION_CLASS dwAclInformationClass ); __declspec(dllimport) BOOL __stdcall SetFileSecurityW( LPCWSTR lpFileName, SECURITY_INFORMATION SecurityInformation, PSECURITY_DESCRIPTOR pSecurityDescriptor ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetKernelObjectSecurity( HANDLE Handle, SECURITY_INFORMATION SecurityInformation, PSECURITY_DESCRIPTOR SecurityDescriptor ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetPrivateObjectSecurity( SECURITY_INFORMATION SecurityInformation, PSECURITY_DESCRIPTOR ModificationDescriptor, PSECURITY_DESCRIPTOR* ObjectsSecurityDescriptor, PGENERIC_MAPPING GenericMapping, HANDLE Token ); __declspec(dllimport) BOOL __stdcall SetPrivateObjectSecurityEx( SECURITY_INFORMATION SecurityInformation, PSECURITY_DESCRIPTOR ModificationDescriptor, PSECURITY_DESCRIPTOR* ObjectsSecurityDescriptor, ULONG AutoInheritFlags, PGENERIC_MAPPING GenericMapping, HANDLE Token ); __declspec(dllimport) void __stdcall SetSecurityAccessMask( SECURITY_INFORMATION SecurityInformation, LPDWORD DesiredAccess ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetSecurityDescriptorControl( PSECURITY_DESCRIPTOR pSecurityDescriptor, SECURITY_DESCRIPTOR_CONTROL ControlBitsOfInterest, SECURITY_DESCRIPTOR_CONTROL ControlBitsToSet ); __declspec(dllimport) BOOL __stdcall SetSecurityDescriptorDacl( PSECURITY_DESCRIPTOR pSecurityDescriptor, BOOL bDaclPresent, PACL pDacl, BOOL bDaclDefaulted ); __declspec(dllimport) BOOL __stdcall SetSecurityDescriptorGroup( PSECURITY_DESCRIPTOR pSecurityDescriptor, PSID pGroup, BOOL bGroupDefaulted ); __declspec(dllimport) BOOL __stdcall SetSecurityDescriptorOwner( PSECURITY_DESCRIPTOR pSecurityDescriptor, PSID pOwner, BOOL bOwnerDefaulted ); __declspec(dllimport) DWORD __stdcall SetSecurityDescriptorRMControl( PSECURITY_DESCRIPTOR SecurityDescriptor, PUCHAR RMControl ); __declspec(dllimport) BOOL __stdcall SetSecurityDescriptorSacl( PSECURITY_DESCRIPTOR pSecurityDescriptor, BOOL bSaclPresent, PACL pSacl, BOOL bSaclDefaulted ); __declspec(dllimport) BOOL __stdcall SetTokenInformation( HANDLE TokenHandle, TOKEN_INFORMATION_CLASS TokenInformationClass, LPVOID TokenInformation, DWORD TokenInformationLength ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetCachedSigningLevel( PHANDLE SourceFiles, ULONG SourceFileCount, ULONG Flags, HANDLE TargetFile ); __declspec(dllimport) BOOL __stdcall GetCachedSigningLevel( HANDLE File, PULONG Flags, PULONG SigningLevel, PUCHAR Thumbprint, PULONG ThumbprintSize, PULONG ThumbprintAlgorithm ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) LONG __stdcall CveEventWrite( PCWSTR CveId, PCWSTR AdditionalDetails ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall DeriveCapabilitySidsFromName( LPCWSTR CapName, PSID** CapabilityGroupSids, DWORD* CapabilityGroupSidCount, PSID** CapabilitySids, DWORD* CapabilitySidCount ); #pragma endregion #line 65 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\namespaceapi.h" #pragma once #pragma region Desktop Family or OneCore Family __declspec(dllimport) HANDLE __stdcall CreatePrivateNamespaceW( LPSECURITY_ATTRIBUTES lpPrivateNamespaceAttributes, LPVOID lpBoundaryDescriptor, LPCWSTR lpAliasPrefix ); __declspec(dllimport) HANDLE __stdcall OpenPrivateNamespaceW( LPVOID lpBoundaryDescriptor, LPCWSTR lpAliasPrefix ); __declspec(dllimport) BOOLEAN __stdcall ClosePrivateNamespace( HANDLE Handle, ULONG Flags ); __declspec(dllimport) HANDLE __stdcall CreateBoundaryDescriptorW( LPCWSTR Name, ULONG Flags ); __declspec(dllimport) BOOL __stdcall AddSIDToBoundaryDescriptor( HANDLE* BoundaryDescriptor, PSID RequiredSid ); __declspec(dllimport) void __stdcall DeleteBoundaryDescriptor( HANDLE BoundaryDescriptor ); #pragma endregion #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\systemtopologyapi.h" #pragma once #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetNumaHighestNodeNumber( PULONG HighestNodeNumber ); __declspec(dllimport) BOOL __stdcall GetNumaNodeProcessorMaskEx( USHORT Node, PGROUP_AFFINITY ProcessorMask ); __declspec(dllimport) BOOL __stdcall GetNumaProximityNodeEx( ULONG ProximityId, PUSHORT NodeNumber ); #pragma endregion #line 67 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\processtopologyapi.h" #pragma once #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetProcessGroupAffinity( HANDLE hProcess, PUSHORT GroupCount, PUSHORT GroupArray ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetThreadGroupAffinity( HANDLE hThread, PGROUP_AFFINITY GroupAffinity ); __declspec(dllimport) BOOL __stdcall SetThreadGroupAffinity( HANDLE hThread, const GROUP_AFFINITY* GroupAffinity, PGROUP_AFFINITY PreviousGroupAffinity ); #pragma endregion #line 68 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\securityappcontainer.h" #pragma once #pragma region Desktop Family or OneCore Family BOOL __stdcall GetAppContainerNamedObjectPath( HANDLE Token, PSID AppContainerSid, ULONG ObjectPathLength, LPWSTR ObjectPath, PULONG ReturnLength ); #pragma endregion #line 69 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\realtimeapiset.h" #pragma once #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall QueryThreadCycleTime( HANDLE ThreadHandle, PULONG64 CycleTime ); __declspec(dllimport) BOOL __stdcall QueryProcessCycleTime( HANDLE ProcessHandle, PULONG64 CycleTime ); __declspec(dllimport) BOOL __stdcall QueryIdleProcessorCycleTime( PULONG BufferLength, PULONG64 ProcessorIdleCycleTime ); __declspec(dllimport) BOOL __stdcall QueryIdleProcessorCycleTimeEx( USHORT Group, PULONG BufferLength, PULONG64 ProcessorIdleCycleTime ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) void __stdcall QueryInterruptTimePrecise( PULONGLONG lpInterruptTimePrecise ); __declspec(dllimport) void __stdcall QueryUnbiasedInterruptTimePrecise( PULONGLONG lpUnbiasedInterruptTimePrecise ); __declspec(dllimport) void __stdcall QueryInterruptTime( PULONGLONG lpInterruptTime ); __declspec(dllimport) BOOL __stdcall QueryUnbiasedInterruptTime( PULONGLONG UnbiasedTime ); __declspec(dllimport) HRESULT __stdcall QueryAuxiliaryCounterFrequency( PULONGLONG lpAuxiliaryCounterFrequency ); __declspec(dllimport) HRESULT __stdcall ConvertAuxiliaryCounterToPerformanceCounter( ULONGLONG ullAuxiliaryCounterValue, PULONGLONG lpPerformanceCounterValue, PULONGLONG lpConversionError ); __declspec(dllimport) HRESULT __stdcall ConvertPerformanceCounterToAuxiliaryCounter( ULONGLONG ullPerformanceCounterValue, PULONGLONG lpAuxiliaryCounterValue, PULONGLONG lpConversionError ); #pragma endregion #line 70 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma region Application Family #pragma endregion #pragma region Desktop Family #pragma endregion #pragma region Application Family or OneCore Family #line 140 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 263 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" typedef void (__stdcall *PFIBER_START_ROUTINE)( LPVOID lpFiberParameter ); typedef PFIBER_START_ROUTINE LPFIBER_START_ROUTINE; typedef LPVOID (__stdcall *PFIBER_CALLOUT_ROUTINE)( LPVOID lpParameter ); typedef LPVOID LPLDT_ENTRY; #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 353 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 365 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 390 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 414 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" typedef struct _COMMPROP { WORD wPacketLength; WORD wPacketVersion; DWORD dwServiceMask; DWORD dwReserved1; DWORD dwMaxTxQueue; DWORD dwMaxRxQueue; DWORD dwMaxBaud; DWORD dwProvSubType; DWORD dwProvCapabilities; DWORD dwSettableParams; DWORD dwSettableBaud; WORD wSettableData; WORD wSettableStopParity; DWORD dwCurrentTxQueue; DWORD dwCurrentRxQueue; DWORD dwProvSpec1; DWORD dwProvSpec2; WCHAR wcProvChar[1]; } COMMPROP,*LPCOMMPROP; typedef struct _COMSTAT { DWORD fCtsHold : 1; DWORD fDsrHold : 1; DWORD fRlsdHold : 1; DWORD fXoffHold : 1; DWORD fXoffSent : 1; DWORD fEof : 1; DWORD fTxim : 1; DWORD fReserved : 25; DWORD cbInQue; DWORD cbOutQue; } COMSTAT, *LPCOMSTAT; typedef struct _DCB { DWORD DCBlength; DWORD BaudRate; DWORD fBinary: 1; DWORD fParity: 1; DWORD fOutxCtsFlow:1; DWORD fOutxDsrFlow:1; DWORD fDtrControl:2; DWORD fDsrSensitivity:1; DWORD fTXContinueOnXoff: 1; DWORD fOutX: 1; DWORD fInX: 1; DWORD fErrorChar: 1; DWORD fNull: 1; DWORD fRtsControl:2; DWORD fAbortOnError:1; DWORD fDummy2:17; WORD wReserved; WORD XonLim; WORD XoffLim; BYTE ByteSize; BYTE Parity; BYTE StopBits; char XonChar; char XoffChar; char ErrorChar; char EofChar; char EvtChar; WORD wReserved1; } DCB, *LPDCB; typedef struct _COMMTIMEOUTS { DWORD ReadIntervalTimeout; DWORD ReadTotalTimeoutMultiplier; DWORD ReadTotalTimeoutConstant; DWORD WriteTotalTimeoutMultiplier; DWORD WriteTotalTimeoutConstant; } COMMTIMEOUTS,*LPCOMMTIMEOUTS; typedef struct _COMMCONFIG { DWORD dwSize; WORD wVersion; WORD wReserved; DCB dcb; DWORD dwProviderSubType; DWORD dwProviderOffset; DWORD dwProviderSize; WCHAR wcProviderData[1]; } COMMCONFIG,*LPCOMMCONFIG; #line 545 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" typedef struct _MEMORYSTATUS { DWORD dwLength; DWORD dwMemoryLoad; SIZE_T dwTotalPhys; SIZE_T dwAvailPhys; SIZE_T dwTotalPageFile; SIZE_T dwAvailPageFile; SIZE_T dwTotalVirtual; SIZE_T dwAvailVirtual; } MEMORYSTATUS, *LPMEMORYSTATUS; #line 629 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" typedef struct _JIT_DEBUG_INFO { DWORD dwSize; DWORD dwProcessorArchitecture; DWORD dwThreadID; DWORD dwReserved0; ULONG64 lpExceptionAddress; ULONG64 lpExceptionRecord; ULONG64 lpContextRecord; } JIT_DEBUG_INFO, *LPJIT_DEBUG_INFO; typedef JIT_DEBUG_INFO JIT_DEBUG_INFO32, *LPJIT_DEBUG_INFO32; typedef JIT_DEBUG_INFO JIT_DEBUG_INFO64, *LPJIT_DEBUG_INFO64; typedef PEXCEPTION_RECORD LPEXCEPTION_RECORD; typedef PEXCEPTION_POINTERS LPEXCEPTION_POINTERS; #line 678 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 730 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 746 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 755 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 773 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 834 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 851 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 863 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 880 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" typedef struct _OFSTRUCT { BYTE cBytes; BYTE fFixedDisk; WORD nErrCode; WORD Reserved1; WORD Reserved2; CHAR szPathName[128]; } OFSTRUCT, *LPOFSTRUCT, *POFSTRUCT; #pragma endregion #pragma region Desktop Family int __stdcall WinMain ( HINSTANCE hInstance, HINSTANCE hPrevInstance, LPSTR lpCmdLine, int nShowCmd ); int __stdcall wWinMain( HINSTANCE hInstance, HINSTANCE hPrevInstance, LPWSTR lpCmdLine, int nShowCmd ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) __declspec(allocator) HGLOBAL __stdcall GlobalAlloc( UINT uFlags, SIZE_T dwBytes ); #pragma endregion #pragma region Application Family __declspec(dllimport) __declspec(allocator) HGLOBAL __stdcall GlobalReAlloc ( HGLOBAL hMem, SIZE_T dwBytes, UINT uFlags ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) SIZE_T __stdcall GlobalSize ( HGLOBAL hMem ); __declspec(dllimport) BOOL __stdcall GlobalUnlock( HGLOBAL hMem ); __declspec(dllimport) LPVOID __stdcall GlobalLock ( HGLOBAL hMem ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) UINT __stdcall GlobalFlags ( HGLOBAL hMem ); __declspec(dllimport) HGLOBAL __stdcall GlobalHandle ( LPCVOID pMem ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) HGLOBAL __stdcall GlobalFree( HGLOBAL hMem ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) SIZE_T __stdcall GlobalCompact( DWORD dwMinFree ); __declspec(dllimport) void __stdcall GlobalFix( HGLOBAL hMem ); __declspec(dllimport) void __stdcall GlobalUnfix( HGLOBAL hMem ); __declspec(dllimport) LPVOID __stdcall GlobalWire( HGLOBAL hMem ); __declspec(dllimport) BOOL __stdcall GlobalUnWire( HGLOBAL hMem ); __declspec(dllimport) void __stdcall GlobalMemoryStatus( LPMEMORYSTATUS lpBuffer ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) __declspec(allocator) HLOCAL __stdcall LocalAlloc( UINT uFlags, SIZE_T uBytes ); __declspec(dllimport) __declspec(allocator) HLOCAL __stdcall LocalReAlloc( HLOCAL hMem, SIZE_T uBytes, UINT uFlags ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) LPVOID __stdcall LocalLock( HLOCAL hMem ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) HLOCAL __stdcall LocalHandle( LPCVOID pMem ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall LocalUnlock( HLOCAL hMem ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) SIZE_T __stdcall LocalSize( HLOCAL hMem ); __declspec(dllimport) UINT __stdcall LocalFlags( HLOCAL hMem ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) HLOCAL __stdcall LocalFree( HLOCAL hMem ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) SIZE_T __stdcall LocalShrink( HLOCAL hMem, UINT cbNewSize ); __declspec(dllimport) SIZE_T __stdcall LocalCompact( UINT uMinFree ); #line 1213 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) BOOL __stdcall GetBinaryTypeA( LPCSTR lpApplicationName, LPDWORD lpBinaryType ); __declspec(dllimport) BOOL __stdcall GetBinaryTypeW( LPCWSTR lpApplicationName, LPDWORD lpBinaryType ); __declspec(dllimport) DWORD __stdcall GetShortPathNameA( LPCSTR lpszLongPath, LPSTR lpszShortPath, DWORD cchBuffer ); __declspec(dllimport) DWORD __stdcall GetLongPathNameTransactedA( LPCSTR lpszShortPath, LPSTR lpszLongPath, DWORD cchBuffer, HANDLE hTransaction ); __declspec(dllimport) DWORD __stdcall GetLongPathNameTransactedW( LPCWSTR lpszShortPath, LPWSTR lpszLongPath, DWORD cchBuffer, HANDLE hTransaction ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetProcessAffinityMask( HANDLE hProcess, PDWORD_PTR lpProcessAffinityMask, PDWORD_PTR lpSystemAffinityMask ); __declspec(dllimport) BOOL __stdcall SetProcessAffinityMask( HANDLE hProcess, DWORD_PTR dwProcessAffinityMask ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall GetProcessIoCounters( HANDLE hProcess, PIO_COUNTERS lpIoCounters ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetProcessWorkingSetSize( HANDLE hProcess, PSIZE_T lpMinimumWorkingSetSize, PSIZE_T lpMaximumWorkingSetSize ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall SetProcessWorkingSetSize( HANDLE hProcess, SIZE_T dwMinimumWorkingSetSize, SIZE_T dwMaximumWorkingSetSize ); __declspec(dllimport) void __stdcall FatalExit( int ExitCode ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetEnvironmentStringsA( LPCH NewEnvironment ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) void __stdcall SwitchToFiber( LPVOID lpFiber ); __declspec(dllimport) void __stdcall DeleteFiber( LPVOID lpFiber ); __declspec(dllimport) BOOL __stdcall ConvertFiberToThread( void ); __declspec(dllimport) LPVOID __stdcall CreateFiberEx( SIZE_T dwStackCommitSize, SIZE_T dwStackReserveSize, DWORD dwFlags, LPFIBER_START_ROUTINE lpStartAddress, LPVOID lpParameter ); __declspec(dllimport) LPVOID __stdcall ConvertThreadToFiberEx( LPVOID lpParameter, DWORD dwFlags ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) LPVOID __stdcall CreateFiber( SIZE_T dwStackSize, LPFIBER_START_ROUTINE lpStartAddress, LPVOID lpParameter ); __declspec(dllimport) LPVOID __stdcall ConvertThreadToFiber( LPVOID lpParameter ); #pragma endregion #pragma region Desktop Family typedef void *PUMS_CONTEXT; typedef void *PUMS_COMPLETION_LIST; typedef enum _RTL_UMS_THREAD_INFO_CLASS UMS_THREAD_INFO_CLASS, *PUMS_THREAD_INFO_CLASS; typedef enum _RTL_UMS_SCHEDULER_REASON UMS_SCHEDULER_REASON; typedef PRTL_UMS_SCHEDULER_ENTRY_POINT PUMS_SCHEDULER_ENTRY_POINT; typedef struct _UMS_SCHEDULER_STARTUP_INFO { ULONG UmsVersion; PUMS_COMPLETION_LIST CompletionList; PUMS_SCHEDULER_ENTRY_POINT SchedulerProc; PVOID SchedulerParam; } UMS_SCHEDULER_STARTUP_INFO, *PUMS_SCHEDULER_STARTUP_INFO; typedef struct _UMS_SYSTEM_THREAD_INFORMATION { ULONG UmsVersion; union { struct { ULONG IsUmsSchedulerThread : 1; ULONG IsUmsWorkerThread : 1; } ; ULONG ThreadUmsFlags; } ; } UMS_SYSTEM_THREAD_INFORMATION, *PUMS_SYSTEM_THREAD_INFORMATION; __declspec(dllimport) BOOL __stdcall CreateUmsCompletionList( PUMS_COMPLETION_LIST* UmsCompletionList ); __declspec(dllimport) BOOL __stdcall DequeueUmsCompletionListItems( PUMS_COMPLETION_LIST UmsCompletionList, DWORD WaitTimeOut, PUMS_CONTEXT* UmsThreadList ); __declspec(dllimport) BOOL __stdcall GetUmsCompletionListEvent( PUMS_COMPLETION_LIST UmsCompletionList, PHANDLE UmsCompletionEvent ); __declspec(dllimport) BOOL __stdcall ExecuteUmsThread( PUMS_CONTEXT UmsThread ); __declspec(dllimport) BOOL __stdcall UmsThreadYield( PVOID SchedulerParam ); __declspec(dllimport) BOOL __stdcall DeleteUmsCompletionList( PUMS_COMPLETION_LIST UmsCompletionList ); __declspec(dllimport) PUMS_CONTEXT __stdcall GetCurrentUmsThread( void ); __declspec(dllimport) PUMS_CONTEXT __stdcall GetNextUmsListItem( PUMS_CONTEXT UmsContext ); __declspec(dllimport) BOOL __stdcall QueryUmsThreadInformation( PUMS_CONTEXT UmsThread, UMS_THREAD_INFO_CLASS UmsThreadInfoClass, PVOID UmsThreadInformation, ULONG UmsThreadInformationLength, PULONG ReturnLength ); __declspec(dllimport) BOOL __stdcall SetUmsThreadInformation( PUMS_CONTEXT UmsThread, UMS_THREAD_INFO_CLASS UmsThreadInfoClass, PVOID UmsThreadInformation, ULONG UmsThreadInformationLength ); __declspec(dllimport) BOOL __stdcall DeleteUmsThreadContext( PUMS_CONTEXT UmsThread ); __declspec(dllimport) BOOL __stdcall CreateUmsThreadContext( PUMS_CONTEXT *lpUmsThread ); __declspec(dllimport) BOOL __stdcall EnterUmsSchedulingMode( PUMS_SCHEDULER_STARTUP_INFO SchedulerStartupInfo ); __declspec(dllimport) BOOL __stdcall GetUmsSystemThreadInformation( HANDLE ThreadHandle, PUMS_SYSTEM_THREAD_INFORMATION SystemThreadInfo ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD_PTR __stdcall SetThreadAffinityMask( HANDLE hThread, DWORD_PTR dwThreadAffinityMask ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall SetProcessDEPPolicy( DWORD dwFlags ); __declspec(dllimport) BOOL __stdcall GetProcessDEPPolicy( HANDLE hProcess, LPDWORD lpFlags, PBOOL lpPermanent ); __declspec(dllimport) BOOL __stdcall RequestWakeupLatency( LATENCY_TIME latency ); __declspec(dllimport) BOOL __stdcall IsSystemResumeAutomatic( void ); __declspec(dllimport) BOOL __stdcall GetThreadSelectorEntry( HANDLE hThread, DWORD dwSelector, LPLDT_ENTRY lpSelectorEntry ); __declspec(dllimport) EXECUTION_STATE __stdcall SetThreadExecutionState( EXECUTION_STATE esFlags ); typedef REASON_CONTEXT POWER_REQUEST_CONTEXT, *PPOWER_REQUEST_CONTEXT, *LPPOWER_REQUEST_CONTEXT; __declspec(dllimport) HANDLE __stdcall PowerCreateRequest ( PREASON_CONTEXT Context ); __declspec(dllimport) BOOL __stdcall PowerSetRequest ( HANDLE PowerRequest, POWER_REQUEST_TYPE RequestType ); __declspec(dllimport) BOOL __stdcall PowerClearRequest ( HANDLE PowerRequest, POWER_REQUEST_TYPE RequestType ); #pragma endregion #pragma region Application Family #pragma endregion #pragma region Desktop Family #line 1780 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetFileCompletionNotificationModes( HANDLE FileHandle, UCHAR Flags ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall Wow64GetThreadContext( HANDLE hThread, PWOW64_CONTEXT lpContext ); __declspec(dllimport) BOOL __stdcall Wow64SetThreadContext( HANDLE hThread, const WOW64_CONTEXT *lpContext ); __declspec(dllimport) BOOL __stdcall Wow64GetThreadSelectorEntry( HANDLE hThread, DWORD dwSelector, PWOW64_LDT_ENTRY lpSelectorEntry ); __declspec(dllimport) DWORD __stdcall Wow64SuspendThread( HANDLE hThread ); __declspec(dllimport) BOOL __stdcall DebugSetProcessKillOnExit( BOOL KillOnExit ); __declspec(dllimport) BOOL __stdcall DebugBreakProcess ( HANDLE Process ); #pragma endregion #pragma region Application Family #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall PulseEvent( HANDLE hEvent ); __declspec(dllimport) ATOM __stdcall GlobalDeleteAtom( ATOM nAtom ); __declspec(dllimport) BOOL __stdcall InitAtomTable( DWORD nSize ); __declspec(dllimport) ATOM __stdcall DeleteAtom( ATOM nAtom ); __declspec(dllimport) UINT __stdcall SetHandleCount( UINT uNumber ); __declspec(dllimport) BOOL __stdcall RequestDeviceWakeup( HANDLE hDevice ); __declspec(dllimport) BOOL __stdcall CancelDeviceWakeupRequest( HANDLE hDevice ); __declspec(dllimport) BOOL __stdcall GetDevicePowerState( HANDLE hDevice, BOOL *pfOn ); __declspec(dllimport) BOOL __stdcall SetMessageWaitingIndicator( HANDLE hMsgIndicator, ULONG ulMsgCount ); __declspec(dllimport) BOOL __stdcall SetFileShortNameA( HANDLE hFile, LPCSTR lpShortName ); __declspec(dllimport) BOOL __stdcall SetFileShortNameW( HANDLE hFile, LPCWSTR lpShortName ); __declspec(dllimport) DWORD __stdcall LoadModule( LPCSTR lpModuleName, LPVOID lpParameterBlock ); __declspec(dllimport) UINT __stdcall WinExec( LPCSTR lpCmdLine, UINT uCmdShow ); #pragma endregion #pragma region Desktop Family or OneCore or App Family __declspec(dllimport) BOOL __stdcall ClearCommBreak( HANDLE hFile ); __declspec(dllimport) BOOL __stdcall ClearCommError( HANDLE hFile, LPDWORD lpErrors, LPCOMSTAT lpStat ); __declspec(dllimport) BOOL __stdcall SetupComm( HANDLE hFile, DWORD dwInQueue, DWORD dwOutQueue ); __declspec(dllimport) BOOL __stdcall EscapeCommFunction( HANDLE hFile, DWORD dwFunc ); __declspec(dllimport) BOOL __stdcall GetCommConfig( HANDLE hCommDev, LPCOMMCONFIG lpCC, LPDWORD lpdwSize ); __declspec(dllimport) BOOL __stdcall GetCommMask( HANDLE hFile, LPDWORD lpEvtMask ); __declspec(dllimport) BOOL __stdcall GetCommProperties( HANDLE hFile, LPCOMMPROP lpCommProp ); __declspec(dllimport) BOOL __stdcall GetCommModemStatus( HANDLE hFile, LPDWORD lpModemStat ); __declspec(dllimport) BOOL __stdcall GetCommState( HANDLE hFile, LPDCB lpDCB ); __declspec(dllimport) BOOL __stdcall GetCommTimeouts( HANDLE hFile, LPCOMMTIMEOUTS lpCommTimeouts ); __declspec(dllimport) BOOL __stdcall PurgeComm( HANDLE hFile, DWORD dwFlags ); __declspec(dllimport) BOOL __stdcall SetCommBreak( HANDLE hFile ); __declspec(dllimport) BOOL __stdcall SetCommConfig( HANDLE hCommDev, LPCOMMCONFIG lpCC, DWORD dwSize ); __declspec(dllimport) BOOL __stdcall SetCommMask( HANDLE hFile, DWORD dwEvtMask ); __declspec(dllimport) BOOL __stdcall SetCommState( HANDLE hFile, LPDCB lpDCB ); __declspec(dllimport) BOOL __stdcall SetCommTimeouts( HANDLE hFile, LPCOMMTIMEOUTS lpCommTimeouts ); __declspec(dllimport) BOOL __stdcall TransmitCommChar( HANDLE hFile, char cChar ); __declspec(dllimport) BOOL __stdcall WaitCommEvent( HANDLE hFile, LPDWORD lpEvtMask, LPOVERLAPPED lpOverlapped ); __declspec(dllimport) HANDLE __stdcall OpenCommPort( ULONG uPortNumber, DWORD dwDesiredAccess, DWORD dwFlagsAndAttributes ); __declspec(dllimport) ULONG __stdcall GetCommPorts( PULONG lpPortNumbers, ULONG uPortNumbersCount, PULONG puPortNumbersFound ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) DWORD __stdcall SetTapePosition( HANDLE hDevice, DWORD dwPositionMethod, DWORD dwPartition, DWORD dwOffsetLow, DWORD dwOffsetHigh, BOOL bImmediate ); __declspec(dllimport) DWORD __stdcall GetTapePosition( HANDLE hDevice, DWORD dwPositionType, LPDWORD lpdwPartition, LPDWORD lpdwOffsetLow, LPDWORD lpdwOffsetHigh ); __declspec(dllimport) DWORD __stdcall PrepareTape( HANDLE hDevice, DWORD dwOperation, BOOL bImmediate ); __declspec(dllimport) DWORD __stdcall EraseTape( HANDLE hDevice, DWORD dwEraseType, BOOL bImmediate ); __declspec(dllimport) DWORD __stdcall CreateTapePartition( HANDLE hDevice, DWORD dwPartitionMethod, DWORD dwCount, DWORD dwSize ); __declspec(dllimport) DWORD __stdcall WriteTapemark( HANDLE hDevice, DWORD dwTapemarkType, DWORD dwTapemarkCount, BOOL bImmediate ); __declspec(dllimport) DWORD __stdcall GetTapeStatus( HANDLE hDevice ); __declspec(dllimport) DWORD __stdcall GetTapeParameters( HANDLE hDevice, DWORD dwOperation, LPDWORD lpdwSize, LPVOID lpTapeInformation ); __declspec(dllimport) DWORD __stdcall SetTapeParameters( HANDLE hDevice, DWORD dwOperation, LPVOID lpTapeInformation ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) int __stdcall MulDiv( int nNumber, int nNumerator, int nDenominator ); #pragma endregion #pragma region Desktop Family typedef enum _DEP_SYSTEM_POLICY_TYPE { DEPPolicyAlwaysOff = 0, DEPPolicyAlwaysOn, DEPPolicyOptIn, DEPPolicyOptOut, DEPTotalPolicyCount } DEP_SYSTEM_POLICY_TYPE; __declspec(dllimport) DEP_SYSTEM_POLICY_TYPE __stdcall GetSystemDEPPolicy( void ); __declspec(dllimport) BOOL __stdcall GetSystemRegistryQuota( PDWORD pdwQuotaAllowed, PDWORD pdwQuotaUsed ); __declspec(dllimport) BOOL __stdcall FileTimeToDosDateTime( const FILETIME *lpFileTime, LPWORD lpFatDate, LPWORD lpFatTime ); __declspec(dllimport) BOOL __stdcall DosDateTimeToFileTime( WORD wFatDate, WORD wFatTime, LPFILETIME lpFileTime ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall FormatMessageA( DWORD dwFlags, LPCVOID lpSource, DWORD dwMessageId, DWORD dwLanguageId, LPSTR lpBuffer, DWORD nSize, va_list *Arguments ); __declspec(dllimport) DWORD __stdcall FormatMessageW( DWORD dwFlags, LPCVOID lpSource, DWORD dwMessageId, DWORD dwLanguageId, LPWSTR lpBuffer, DWORD nSize, va_list *Arguments ); #line 2449 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 2456 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Desktop Family __declspec(dllimport) HANDLE __stdcall CreateMailslotA( LPCSTR lpName, DWORD nMaxMessageSize, DWORD lReadTimeout, LPSECURITY_ATTRIBUTES lpSecurityAttributes ); __declspec(dllimport) HANDLE __stdcall CreateMailslotW( LPCWSTR lpName, DWORD nMaxMessageSize, DWORD lReadTimeout, LPSECURITY_ATTRIBUTES lpSecurityAttributes ); __declspec(dllimport) BOOL __stdcall GetMailslotInfo( HANDLE hMailslot, LPDWORD lpMaxMessageSize, LPDWORD lpNextSize, LPDWORD lpMessageCount, LPDWORD lpReadTimeout ); __declspec(dllimport) BOOL __stdcall SetMailslotInfo( HANDLE hMailslot, DWORD lReadTimeout ); __declspec(dllimport) BOOL __stdcall EncryptFileA( LPCSTR lpFileName ); __declspec(dllimport) BOOL __stdcall EncryptFileW( LPCWSTR lpFileName ); __declspec(dllimport) BOOL __stdcall DecryptFileA( LPCSTR lpFileName, DWORD dwReserved ); __declspec(dllimport) BOOL __stdcall DecryptFileW( LPCWSTR lpFileName, DWORD dwReserved ); #line 2563 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) BOOL __stdcall FileEncryptionStatusA( LPCSTR lpFileName, LPDWORD lpStatus ); __declspec(dllimport) BOOL __stdcall FileEncryptionStatusW( LPCWSTR lpFileName, LPDWORD lpStatus ); typedef DWORD (__stdcall *PFE_EXPORT_FUNC)( PBYTE pbData, PVOID pvCallbackContext, ULONG ulLength ); typedef DWORD (__stdcall *PFE_IMPORT_FUNC)( PBYTE pbData, PVOID pvCallbackContext, PULONG ulLength ); __declspec(dllimport) DWORD __stdcall OpenEncryptedFileRawA( LPCSTR lpFileName, ULONG ulFlags, PVOID *pvContext ); __declspec(dllimport) DWORD __stdcall OpenEncryptedFileRawW( LPCWSTR lpFileName, ULONG ulFlags, PVOID *pvContext ); __declspec(dllimport) DWORD __stdcall ReadEncryptedFileRaw( PFE_EXPORT_FUNC pfExportCallback, PVOID pvCallbackContext, PVOID pvContext ); __declspec(dllimport) DWORD __stdcall WriteEncryptedFileRaw( PFE_IMPORT_FUNC pfImportCallback, PVOID pvCallbackContext, PVOID pvContext ); __declspec(dllimport) void __stdcall CloseEncryptedFileRaw( PVOID pvContext ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) int __stdcall lstrcmpA( LPCSTR lpString1, LPCSTR lpString2 ); __declspec(dllimport) int __stdcall lstrcmpW( LPCWSTR lpString1, LPCWSTR lpString2 ); __declspec(dllimport) int __stdcall lstrcmpiA( LPCSTR lpString1, LPCSTR lpString2 ); __declspec(dllimport) int __stdcall lstrcmpiW( LPCWSTR lpString1, LPCWSTR lpString2 ); #pragma warning(push) #pragma warning(disable:4995) __declspec(dllimport) LPSTR __stdcall lstrcpynA( LPSTR lpString1, LPCSTR lpString2, int iMaxLength ); __declspec(dllimport) LPWSTR __stdcall lstrcpynW( LPWSTR lpString1, LPCWSTR lpString2, int iMaxLength ); __declspec(dllimport) LPSTR __stdcall lstrcpyA( LPSTR lpString1, LPCSTR lpString2 ); __declspec(dllimport) LPWSTR __stdcall lstrcpyW( LPWSTR lpString1, LPCWSTR lpString2 ); __declspec(dllimport) LPSTR __stdcall lstrcatA( LPSTR lpString1, LPCSTR lpString2 ); __declspec(dllimport) LPWSTR __stdcall lstrcatW( LPWSTR lpString1, LPCWSTR lpString2 ); #pragma warning(pop) __declspec(dllimport) int __stdcall lstrlenA( LPCSTR lpString ); __declspec(dllimport) int __stdcall lstrlenW( LPCWSTR lpString ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) HFILE __stdcall OpenFile( LPCSTR lpFileName, LPOFSTRUCT lpReOpenBuff, UINT uStyle ); __declspec(dllimport) HFILE __stdcall _lopen( LPCSTR lpPathName, int iReadWrite ); __declspec(dllimport) HFILE __stdcall _lcreat( LPCSTR lpPathName, int iAttribute ); __declspec(dllimport) UINT __stdcall _lread( HFILE hFile, LPVOID lpBuffer, UINT uBytes ); __declspec(dllimport) UINT __stdcall _lwrite( HFILE hFile, LPCCH lpBuffer, UINT uBytes ); __declspec(dllimport) long __stdcall _hread( HFILE hFile, LPVOID lpBuffer, long lBytes ); __declspec(dllimport) long __stdcall _hwrite( HFILE hFile, LPCCH lpBuffer, long lBytes ); __declspec(dllimport) HFILE __stdcall _lclose( HFILE hFile ); __declspec(dllimport) LONG __stdcall _llseek( HFILE hFile, LONG lOffset, int iOrigin ); __declspec(dllimport) BOOL __stdcall IsTextUnicode( const void* lpv, int iSize, LPINT lpiResult ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) DWORD __stdcall SignalObjectAndWait( HANDLE hObjectToSignal, HANDLE hObjectToWaitOn, DWORD dwMilliseconds, BOOL bAlertable ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall BackupRead( HANDLE hFile, LPBYTE lpBuffer, DWORD nNumberOfBytesToRead, LPDWORD lpNumberOfBytesRead, BOOL bAbort, BOOL bProcessSecurity, LPVOID *lpContext ); __declspec(dllimport) BOOL __stdcall BackupSeek( HANDLE hFile, DWORD dwLowBytesToSeek, DWORD dwHighBytesToSeek, LPDWORD lpdwLowByteSeeked, LPDWORD lpdwHighByteSeeked, LPVOID *lpContext ); __declspec(dllimport) BOOL __stdcall BackupWrite( HANDLE hFile, LPBYTE lpBuffer, DWORD nNumberOfBytesToWrite, LPDWORD lpNumberOfBytesWritten, BOOL bAbort, BOOL bProcessSecurity, LPVOID *lpContext ); typedef struct _WIN32_STREAM_ID { DWORD dwStreamId ; DWORD dwStreamAttributes ; LARGE_INTEGER Size ; DWORD dwStreamNameSize ; WCHAR cStreamName[ 1 ] ; } WIN32_STREAM_ID, *LPWIN32_STREAM_ID ; #line 2993 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 3004 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 3018 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" typedef struct _STARTUPINFOEXA { STARTUPINFOA StartupInfo; LPPROC_THREAD_ATTRIBUTE_LIST lpAttributeList; } STARTUPINFOEXA, *LPSTARTUPINFOEXA; typedef struct _STARTUPINFOEXW { STARTUPINFOW StartupInfo; LPPROC_THREAD_ATTRIBUTE_LIST lpAttributeList; } STARTUPINFOEXW, *LPSTARTUPINFOEXW; typedef STARTUPINFOEXA STARTUPINFOEX; typedef LPSTARTUPINFOEXA LPSTARTUPINFOEX; #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) HANDLE __stdcall OpenMutexA( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCSTR lpName ); __declspec(dllimport) HANDLE __stdcall CreateSemaphoreA( LPSECURITY_ATTRIBUTES lpSemaphoreAttributes, LONG lInitialCount, LONG lMaximumCount, LPCSTR lpName ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HANDLE __stdcall OpenSemaphoreA( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCSTR lpName ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HANDLE __stdcall CreateWaitableTimerA( LPSECURITY_ATTRIBUTES lpTimerAttributes, BOOL bManualReset, LPCSTR lpTimerName ); __declspec(dllimport) HANDLE __stdcall OpenWaitableTimerA( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCSTR lpTimerName ); __declspec(dllimport) HANDLE __stdcall CreateSemaphoreExA( LPSECURITY_ATTRIBUTES lpSemaphoreAttributes, LONG lInitialCount, LONG lMaximumCount, LPCSTR lpName, DWORD dwFlags, DWORD dwDesiredAccess ); __declspec(dllimport) HANDLE __stdcall CreateWaitableTimerExA( LPSECURITY_ATTRIBUTES lpTimerAttributes, LPCSTR lpTimerName, DWORD dwFlags, DWORD dwDesiredAccess ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) HANDLE __stdcall CreateFileMappingA( HANDLE hFile, LPSECURITY_ATTRIBUTES lpFileMappingAttributes, DWORD flProtect, DWORD dwMaximumSizeHigh, DWORD dwMaximumSizeLow, LPCSTR lpName ); __declspec(dllimport) HANDLE __stdcall CreateFileMappingNumaA( HANDLE hFile, LPSECURITY_ATTRIBUTES lpFileMappingAttributes, DWORD flProtect, DWORD dwMaximumSizeHigh, DWORD dwMaximumSizeLow, LPCSTR lpName, DWORD nndPreferred ); __declspec(dllimport) HANDLE __stdcall OpenFileMappingA( DWORD dwDesiredAccess, BOOL bInheritHandle, LPCSTR lpName ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetLogicalDriveStringsA( DWORD nBufferLength, LPSTR lpBuffer ); #pragma endregion #pragma region Desktop Family #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) HMODULE __stdcall LoadPackagedLibrary ( LPCWSTR lpwLibFileName, DWORD Reserved ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall QueryFullProcessImageNameA( HANDLE hProcess, DWORD dwFlags, LPSTR lpExeName, PDWORD lpdwSize ); __declspec(dllimport) BOOL __stdcall QueryFullProcessImageNameW( HANDLE hProcess, DWORD dwFlags, LPWSTR lpExeName, PDWORD lpdwSize ); typedef enum _PROC_THREAD_ATTRIBUTE_NUM { ProcThreadAttributeParentProcess = 0, ProcThreadAttributeHandleList = 2, ProcThreadAttributeGroupAffinity = 3, ProcThreadAttributePreferredNode = 4, ProcThreadAttributeIdealProcessor = 5, ProcThreadAttributeUmsThread = 6, ProcThreadAttributeMitigationPolicy = 7, ProcThreadAttributeSecurityCapabilities = 9, ProcThreadAttributeProtectionLevel = 11, ProcThreadAttributeJobList = 13, ProcThreadAttributeChildProcessPolicy = 14, ProcThreadAttributeAllApplicationPackagesPolicy = 15, ProcThreadAttributeWin32kFilter = 16, ProcThreadAttributeSafeOpenPromptOriginClaim = 17, ProcThreadAttributeDesktopAppPolicy = 18, } PROC_THREAD_ATTRIBUTE_NUM; #line 3413 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Desktop Family __declspec(dllimport) void __stdcall GetStartupInfoA( LPSTARTUPINFOA lpStartupInfo ); #line 3753 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 3773 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region OneCore Family or App Family __declspec(dllimport) DWORD __stdcall GetFirmwareEnvironmentVariableA( LPCSTR lpName, LPCSTR lpGuid, PVOID pBuffer, DWORD nSize ); __declspec(dllimport) DWORD __stdcall GetFirmwareEnvironmentVariableW( LPCWSTR lpName, LPCWSTR lpGuid, PVOID pBuffer, DWORD nSize ); __declspec(dllimport) DWORD __stdcall GetFirmwareEnvironmentVariableExA( LPCSTR lpName, LPCSTR lpGuid, PVOID pBuffer, DWORD nSize, PDWORD pdwAttribubutes ); __declspec(dllimport) DWORD __stdcall GetFirmwareEnvironmentVariableExW( LPCWSTR lpName, LPCWSTR lpGuid, PVOID pBuffer, DWORD nSize, PDWORD pdwAttribubutes ); __declspec(dllimport) BOOL __stdcall SetFirmwareEnvironmentVariableA( LPCSTR lpName, LPCSTR lpGuid, PVOID pValue, DWORD nSize ); __declspec(dllimport) BOOL __stdcall SetFirmwareEnvironmentVariableW( LPCWSTR lpName, LPCWSTR lpGuid, PVOID pValue, DWORD nSize ); __declspec(dllimport) BOOL __stdcall SetFirmwareEnvironmentVariableExA( LPCSTR lpName, LPCSTR lpGuid, PVOID pValue, DWORD nSize, DWORD dwAttributes ); __declspec(dllimport) BOOL __stdcall SetFirmwareEnvironmentVariableExW( LPCWSTR lpName, LPCWSTR lpGuid, PVOID pValue, DWORD nSize, DWORD dwAttributes ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall GetFirmwareType ( PFIRMWARE_TYPE FirmwareType ); __declspec(dllimport) BOOL __stdcall IsNativeVhdBoot ( PBOOL NativeVhdBoot ); __declspec(dllimport) HRSRC __stdcall FindResourceA( HMODULE hModule, LPCSTR lpName, LPCSTR lpType ); __declspec(dllimport) HRSRC __stdcall FindResourceExA( HMODULE hModule, LPCSTR lpType, LPCSTR lpName, WORD wLanguage ); __declspec(dllimport) BOOL __stdcall EnumResourceTypesA( HMODULE hModule, ENUMRESTYPEPROCA lpEnumFunc, LONG_PTR lParam ); __declspec(dllimport) BOOL __stdcall EnumResourceTypesW( HMODULE hModule, ENUMRESTYPEPROCW lpEnumFunc, LONG_PTR lParam ); __declspec(dllimport) BOOL __stdcall EnumResourceNamesA( HMODULE hModule, LPCSTR lpType, ENUMRESNAMEPROCA lpEnumFunc, LONG_PTR lParam ); __declspec(dllimport) BOOL __stdcall EnumResourceLanguagesA( HMODULE hModule, LPCSTR lpType, LPCSTR lpName, ENUMRESLANGPROCA lpEnumFunc, LONG_PTR lParam ); __declspec(dllimport) BOOL __stdcall EnumResourceLanguagesW( HMODULE hModule, LPCWSTR lpType, LPCWSTR lpName, ENUMRESLANGPROCW lpEnumFunc, LONG_PTR lParam ); __declspec(dllimport) HANDLE __stdcall BeginUpdateResourceA( LPCSTR pFileName, BOOL bDeleteExistingResources ); __declspec(dllimport) HANDLE __stdcall BeginUpdateResourceW( LPCWSTR pFileName, BOOL bDeleteExistingResources ); __declspec(dllimport) BOOL __stdcall UpdateResourceA( HANDLE hUpdate, LPCSTR lpType, LPCSTR lpName, WORD wLanguage, LPVOID lpData, DWORD cb ); __declspec(dllimport) BOOL __stdcall UpdateResourceW( HANDLE hUpdate, LPCWSTR lpType, LPCWSTR lpName, WORD wLanguage, LPVOID lpData, DWORD cb ); __declspec(dllimport) BOOL __stdcall EndUpdateResourceA( HANDLE hUpdate, BOOL fDiscard ); __declspec(dllimport) BOOL __stdcall EndUpdateResourceW( HANDLE hUpdate, BOOL fDiscard ); __declspec(dllimport) ATOM __stdcall GlobalAddAtomA( LPCSTR lpString ); __declspec(dllimport) ATOM __stdcall GlobalAddAtomW( LPCWSTR lpString ); __declspec(dllimport) ATOM __stdcall GlobalAddAtomExA( LPCSTR lpString, DWORD Flags ); __declspec(dllimport) ATOM __stdcall GlobalAddAtomExW( LPCWSTR lpString, DWORD Flags ); __declspec(dllimport) ATOM __stdcall GlobalFindAtomA( LPCSTR lpString ); __declspec(dllimport) ATOM __stdcall GlobalFindAtomW( LPCWSTR lpString ); __declspec(dllimport) UINT __stdcall GlobalGetAtomNameA( ATOM nAtom, LPSTR lpBuffer, int nSize ); __declspec(dllimport) UINT __stdcall GlobalGetAtomNameW( ATOM nAtom, LPWSTR lpBuffer, int nSize ); __declspec(dllimport) ATOM __stdcall AddAtomA( LPCSTR lpString ); __declspec(dllimport) ATOM __stdcall AddAtomW( LPCWSTR lpString ); __declspec(dllimport) ATOM __stdcall FindAtomA( LPCSTR lpString ); __declspec(dllimport) ATOM __stdcall FindAtomW( LPCWSTR lpString ); __declspec(dllimport) UINT __stdcall GetAtomNameA( ATOM nAtom, LPSTR lpBuffer, int nSize ); __declspec(dllimport) UINT __stdcall GetAtomNameW( ATOM nAtom, LPWSTR lpBuffer, int nSize ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) UINT __stdcall GetProfileIntA( LPCSTR lpAppName, LPCSTR lpKeyName, INT nDefault ); __declspec(dllimport) UINT __stdcall GetProfileIntW( LPCWSTR lpAppName, LPCWSTR lpKeyName, INT nDefault ); __declspec(dllimport) DWORD __stdcall GetProfileStringA( LPCSTR lpAppName, LPCSTR lpKeyName, LPCSTR lpDefault, LPSTR lpReturnedString, DWORD nSize ); __declspec(dllimport) DWORD __stdcall GetProfileStringW( LPCWSTR lpAppName, LPCWSTR lpKeyName, LPCWSTR lpDefault, LPWSTR lpReturnedString, DWORD nSize ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall WriteProfileStringA( LPCSTR lpAppName, LPCSTR lpKeyName, LPCSTR lpString ); __declspec(dllimport) BOOL __stdcall WriteProfileStringW( LPCWSTR lpAppName, LPCWSTR lpKeyName, LPCWSTR lpString ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) DWORD __stdcall GetProfileSectionA( LPCSTR lpAppName, LPSTR lpReturnedString, DWORD nSize ); __declspec(dllimport) DWORD __stdcall GetProfileSectionW( LPCWSTR lpAppName, LPWSTR lpReturnedString, DWORD nSize ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall WriteProfileSectionA( LPCSTR lpAppName, LPCSTR lpString ); __declspec(dllimport) BOOL __stdcall WriteProfileSectionW( LPCWSTR lpAppName, LPCWSTR lpString ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) UINT __stdcall GetPrivateProfileIntA( LPCSTR lpAppName, LPCSTR lpKeyName, INT nDefault, LPCSTR lpFileName ); __declspec(dllimport) UINT __stdcall GetPrivateProfileIntW( LPCWSTR lpAppName, LPCWSTR lpKeyName, INT nDefault, LPCWSTR lpFileName ); #line 4397 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) DWORD __stdcall GetPrivateProfileStringA( LPCSTR lpAppName, LPCSTR lpKeyName, LPCSTR lpDefault, LPSTR lpReturnedString, DWORD nSize, LPCSTR lpFileName ); __declspec(dllimport) DWORD __stdcall GetPrivateProfileStringW( LPCWSTR lpAppName, LPCWSTR lpKeyName, LPCWSTR lpDefault, LPWSTR lpReturnedString, DWORD nSize, LPCWSTR lpFileName ); #line 4453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) BOOL __stdcall WritePrivateProfileStringA( LPCSTR lpAppName, LPCSTR lpKeyName, LPCSTR lpString, LPCSTR lpFileName ); __declspec(dllimport) BOOL __stdcall WritePrivateProfileStringW( LPCWSTR lpAppName, LPCWSTR lpKeyName, LPCWSTR lpString, LPCWSTR lpFileName ); __declspec(dllimport) DWORD __stdcall GetPrivateProfileSectionA( LPCSTR lpAppName, LPSTR lpReturnedString, DWORD nSize, LPCSTR lpFileName ); __declspec(dllimport) DWORD __stdcall GetPrivateProfileSectionW( LPCWSTR lpAppName, LPWSTR lpReturnedString, DWORD nSize, LPCWSTR lpFileName ); #line 4525 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) BOOL __stdcall WritePrivateProfileSectionA( LPCSTR lpAppName, LPCSTR lpString, LPCSTR lpFileName ); __declspec(dllimport) BOOL __stdcall WritePrivateProfileSectionW( LPCWSTR lpAppName, LPCWSTR lpString, LPCWSTR lpFileName ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) DWORD __stdcall GetPrivateProfileSectionNamesA( LPSTR lpszReturnBuffer, DWORD nSize, LPCSTR lpFileName ); __declspec(dllimport) DWORD __stdcall GetPrivateProfileSectionNamesW( LPWSTR lpszReturnBuffer, DWORD nSize, LPCWSTR lpFileName ); #line 4597 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) BOOL __stdcall GetPrivateProfileStructA( LPCSTR lpszSection, LPCSTR lpszKey, LPVOID lpStruct, UINT uSizeStruct, LPCSTR szFile ); __declspec(dllimport) BOOL __stdcall GetPrivateProfileStructW( LPCWSTR lpszSection, LPCWSTR lpszKey, LPVOID lpStruct, UINT uSizeStruct, LPCWSTR szFile ); #line 4649 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) BOOL __stdcall WritePrivateProfileStructA( LPCSTR lpszSection, LPCSTR lpszKey, LPVOID lpStruct, UINT uSizeStruct, LPCSTR szFile ); __declspec(dllimport) BOOL __stdcall WritePrivateProfileStructW( LPCWSTR lpszSection, LPCWSTR lpszKey, LPVOID lpStruct, UINT uSizeStruct, LPCWSTR szFile ); #line 4699 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) BOOLEAN __stdcall Wow64EnableWow64FsRedirection ( BOOLEAN Wow64FsEnableRedirection ); typedef UINT (__stdcall* PGET_SYSTEM_WOW64_DIRECTORY_A)( LPSTR lpBuffer, UINT uSize); typedef UINT (__stdcall* PGET_SYSTEM_WOW64_DIRECTORY_W)( LPWSTR lpBuffer, UINT uSize); #line 4727 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 4737 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 4758 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 4778 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) BOOL __stdcall SetDllDirectoryA( LPCSTR lpPathName ); __declspec(dllimport) BOOL __stdcall SetDllDirectoryW( LPCWSTR lpPathName ); __declspec(dllimport) DWORD __stdcall GetDllDirectoryA( DWORD nBufferLength, LPSTR lpBuffer ); __declspec(dllimport) DWORD __stdcall GetDllDirectoryW( DWORD nBufferLength, LPWSTR lpBuffer ); __declspec(dllimport) BOOL __stdcall SetSearchPathMode ( DWORD Flags ); #pragma endregion #pragma region Application Family #line 4860 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall CreateDirectoryExA( LPCSTR lpTemplateDirectory, LPCSTR lpNewDirectory, LPSECURITY_ATTRIBUTES lpSecurityAttributes ); __declspec(dllimport) BOOL __stdcall CreateDirectoryExW( LPCWSTR lpTemplateDirectory, LPCWSTR lpNewDirectory, LPSECURITY_ATTRIBUTES lpSecurityAttributes ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall CreateDirectoryTransactedA( LPCSTR lpTemplateDirectory, LPCSTR lpNewDirectory, LPSECURITY_ATTRIBUTES lpSecurityAttributes, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall CreateDirectoryTransactedW( LPCWSTR lpTemplateDirectory, LPCWSTR lpNewDirectory, LPSECURITY_ATTRIBUTES lpSecurityAttributes, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall RemoveDirectoryTransactedA( LPCSTR lpPathName, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall RemoveDirectoryTransactedW( LPCWSTR lpPathName, HANDLE hTransaction ); __declspec(dllimport) DWORD __stdcall GetFullPathNameTransactedA( LPCSTR lpFileName, DWORD nBufferLength, LPSTR lpBuffer, LPSTR *lpFilePart, HANDLE hTransaction ); __declspec(dllimport) DWORD __stdcall GetFullPathNameTransactedW( LPCWSTR lpFileName, DWORD nBufferLength, LPWSTR lpBuffer, LPWSTR *lpFilePart, HANDLE hTransaction ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall DefineDosDeviceA( DWORD dwFlags, LPCSTR lpDeviceName, LPCSTR lpTargetPath ); __declspec(dllimport) DWORD __stdcall QueryDosDeviceA( LPCSTR lpDeviceName, LPSTR lpTargetPath, DWORD ucchMax ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) HANDLE __stdcall CreateFileTransactedA( LPCSTR lpFileName, DWORD dwDesiredAccess, DWORD dwShareMode, LPSECURITY_ATTRIBUTES lpSecurityAttributes, DWORD dwCreationDisposition, DWORD dwFlagsAndAttributes, HANDLE hTemplateFile, HANDLE hTransaction, PUSHORT pusMiniVersion, PVOID lpExtendedParameter ); __declspec(dllimport) HANDLE __stdcall CreateFileTransactedW( LPCWSTR lpFileName, DWORD dwDesiredAccess, DWORD dwShareMode, LPSECURITY_ATTRIBUTES lpSecurityAttributes, DWORD dwCreationDisposition, DWORD dwFlagsAndAttributes, HANDLE hTemplateFile, HANDLE hTransaction, PUSHORT pusMiniVersion, PVOID lpExtendedParameter ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) HANDLE __stdcall ReOpenFile( HANDLE hOriginalFile, DWORD dwDesiredAccess, DWORD dwShareMode, DWORD dwFlagsAndAttributes ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall SetFileAttributesTransactedA( LPCSTR lpFileName, DWORD dwFileAttributes, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall SetFileAttributesTransactedW( LPCWSTR lpFileName, DWORD dwFileAttributes, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall GetFileAttributesTransactedA( LPCSTR lpFileName, GET_FILEEX_INFO_LEVELS fInfoLevelId, LPVOID lpFileInformation, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall GetFileAttributesTransactedW( LPCWSTR lpFileName, GET_FILEEX_INFO_LEVELS fInfoLevelId, LPVOID lpFileInformation, HANDLE hTransaction ); __declspec(dllimport) DWORD __stdcall GetCompressedFileSizeTransactedA( LPCSTR lpFileName, LPDWORD lpFileSizeHigh, HANDLE hTransaction ); __declspec(dllimport) DWORD __stdcall GetCompressedFileSizeTransactedW( LPCWSTR lpFileName, LPDWORD lpFileSizeHigh, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall DeleteFileTransactedA( LPCSTR lpFileName, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall DeleteFileTransactedW( LPCWSTR lpFileName, HANDLE hTransaction ); #pragma endregion #pragma region Application Family #line 5197 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall CheckNameLegalDOS8Dot3A( LPCSTR lpName, LPSTR lpOemName, DWORD OemNameSize, PBOOL pbNameContainsSpaces , PBOOL pbNameLegal ); __declspec(dllimport) BOOL __stdcall CheckNameLegalDOS8Dot3W( LPCWSTR lpName, LPSTR lpOemName, DWORD OemNameSize, PBOOL pbNameContainsSpaces , PBOOL pbNameLegal ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) HANDLE __stdcall FindFirstFileTransactedA( LPCSTR lpFileName, FINDEX_INFO_LEVELS fInfoLevelId, LPVOID lpFindFileData, FINDEX_SEARCH_OPS fSearchOp, LPVOID lpSearchFilter, DWORD dwAdditionalFlags, HANDLE hTransaction ); __declspec(dllimport) HANDLE __stdcall FindFirstFileTransactedW( LPCWSTR lpFileName, FINDEX_INFO_LEVELS fInfoLevelId, LPVOID lpFindFileData, FINDEX_SEARCH_OPS fSearchOp, LPVOID lpSearchFilter, DWORD dwAdditionalFlags, HANDLE hTransaction ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall CopyFileA( LPCSTR lpExistingFileName, LPCSTR lpNewFileName, BOOL bFailIfExists ); __declspec(dllimport) BOOL __stdcall CopyFileW( LPCWSTR lpExistingFileName, LPCWSTR lpNewFileName, BOOL bFailIfExists ); #line 5328 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Application Family or OneCore Family typedef DWORD (__stdcall *LPPROGRESS_ROUTINE)( LARGE_INTEGER TotalFileSize, LARGE_INTEGER TotalBytesTransferred, LARGE_INTEGER StreamSize, LARGE_INTEGER StreamBytesTransferred, DWORD dwStreamNumber, DWORD dwCallbackReason, HANDLE hSourceFile, HANDLE hDestinationFile, LPVOID lpData ); __declspec(dllimport) BOOL __stdcall CopyFileExA( LPCSTR lpExistingFileName, LPCSTR lpNewFileName, LPPROGRESS_ROUTINE lpProgressRoutine, LPVOID lpData, LPBOOL pbCancel, DWORD dwCopyFlags ); __declspec(dllimport) BOOL __stdcall CopyFileExW( LPCWSTR lpExistingFileName, LPCWSTR lpNewFileName, LPPROGRESS_ROUTINE lpProgressRoutine, LPVOID lpData, LPBOOL pbCancel, DWORD dwCopyFlags ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall CopyFileTransactedA( LPCSTR lpExistingFileName, LPCSTR lpNewFileName, LPPROGRESS_ROUTINE lpProgressRoutine, LPVOID lpData, LPBOOL pbCancel, DWORD dwCopyFlags, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall CopyFileTransactedW( LPCWSTR lpExistingFileName, LPCWSTR lpNewFileName, LPPROGRESS_ROUTINE lpProgressRoutine, LPVOID lpData, LPBOOL pbCancel, DWORD dwCopyFlags, HANDLE hTransaction ); #pragma endregion #pragma region Application Family typedef enum _COPYFILE2_MESSAGE_TYPE { COPYFILE2_CALLBACK_NONE = 0, COPYFILE2_CALLBACK_CHUNK_STARTED, COPYFILE2_CALLBACK_CHUNK_FINISHED, COPYFILE2_CALLBACK_STREAM_STARTED, COPYFILE2_CALLBACK_STREAM_FINISHED, COPYFILE2_CALLBACK_POLL_CONTINUE, COPYFILE2_CALLBACK_ERROR, COPYFILE2_CALLBACK_MAX, } COPYFILE2_MESSAGE_TYPE; typedef enum _COPYFILE2_MESSAGE_ACTION { COPYFILE2_PROGRESS_CONTINUE = 0, COPYFILE2_PROGRESS_CANCEL, COPYFILE2_PROGRESS_STOP, COPYFILE2_PROGRESS_QUIET, COPYFILE2_PROGRESS_PAUSE, } COPYFILE2_MESSAGE_ACTION; typedef enum _COPYFILE2_COPY_PHASE { COPYFILE2_PHASE_NONE = 0, COPYFILE2_PHASE_PREPARE_SOURCE, COPYFILE2_PHASE_PREPARE_DEST, COPYFILE2_PHASE_READ_SOURCE, COPYFILE2_PHASE_WRITE_DESTINATION, COPYFILE2_PHASE_SERVER_COPY, COPYFILE2_PHASE_NAMEGRAFT_COPY, COPYFILE2_PHASE_MAX, } COPYFILE2_COPY_PHASE; typedef struct COPYFILE2_MESSAGE { COPYFILE2_MESSAGE_TYPE Type; DWORD dwPadding; union { struct { DWORD dwStreamNumber; DWORD dwReserved; HANDLE hSourceFile; HANDLE hDestinationFile; ULARGE_INTEGER uliChunkNumber; ULARGE_INTEGER uliChunkSize; ULARGE_INTEGER uliStreamSize; ULARGE_INTEGER uliTotalFileSize; } ChunkStarted; struct { DWORD dwStreamNumber; DWORD dwFlags; HANDLE hSourceFile; HANDLE hDestinationFile; ULARGE_INTEGER uliChunkNumber; ULARGE_INTEGER uliChunkSize; ULARGE_INTEGER uliStreamSize; ULARGE_INTEGER uliStreamBytesTransferred; ULARGE_INTEGER uliTotalFileSize; ULARGE_INTEGER uliTotalBytesTransferred; } ChunkFinished; struct { DWORD dwStreamNumber; DWORD dwReserved; HANDLE hSourceFile; HANDLE hDestinationFile; ULARGE_INTEGER uliStreamSize; ULARGE_INTEGER uliTotalFileSize; } StreamStarted; struct { DWORD dwStreamNumber; DWORD dwReserved; HANDLE hSourceFile; HANDLE hDestinationFile; ULARGE_INTEGER uliStreamSize; ULARGE_INTEGER uliStreamBytesTransferred; ULARGE_INTEGER uliTotalFileSize; ULARGE_INTEGER uliTotalBytesTransferred; } StreamFinished; struct { DWORD dwReserved; } PollContinue; struct { COPYFILE2_COPY_PHASE CopyPhase; DWORD dwStreamNumber; HRESULT hrFailure; DWORD dwReserved; ULARGE_INTEGER uliChunkNumber; ULARGE_INTEGER uliStreamSize; ULARGE_INTEGER uliStreamBytesTransferred; ULARGE_INTEGER uliTotalFileSize; ULARGE_INTEGER uliTotalBytesTransferred; } Error; } Info; } COPYFILE2_MESSAGE; typedef COPYFILE2_MESSAGE_ACTION (__stdcall *PCOPYFILE2_PROGRESS_ROUTINE)( const COPYFILE2_MESSAGE *pMessage, PVOID pvCallbackContext ); typedef struct COPYFILE2_EXTENDED_PARAMETERS { DWORD dwSize; DWORD dwCopyFlags; BOOL *pfCancel; PCOPYFILE2_PROGRESS_ROUTINE pProgressRoutine; PVOID pvCallbackContext; } COPYFILE2_EXTENDED_PARAMETERS; __declspec(dllimport) HRESULT __stdcall CopyFile2( PCWSTR pwszExistingFileName, PCWSTR pwszNewFileName, COPYFILE2_EXTENDED_PARAMETERS *pExtendedParameters ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall MoveFileA( LPCSTR lpExistingFileName, LPCSTR lpNewFileName ); __declspec(dllimport) BOOL __stdcall MoveFileW( LPCWSTR lpExistingFileName, LPCWSTR lpNewFileName ); #line 5609 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall MoveFileExA( LPCSTR lpExistingFileName, LPCSTR lpNewFileName, DWORD dwFlags ); __declspec(dllimport) BOOL __stdcall MoveFileExW( LPCWSTR lpExistingFileName, LPCWSTR lpNewFileName, DWORD dwFlags ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall MoveFileWithProgressA( LPCSTR lpExistingFileName, LPCSTR lpNewFileName, LPPROGRESS_ROUTINE lpProgressRoutine, LPVOID lpData, DWORD dwFlags ); __declspec(dllimport) BOOL __stdcall MoveFileWithProgressW( LPCWSTR lpExistingFileName, LPCWSTR lpNewFileName, LPPROGRESS_ROUTINE lpProgressRoutine, LPVOID lpData, DWORD dwFlags ); #line 5671 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall MoveFileTransactedA( LPCSTR lpExistingFileName, LPCSTR lpNewFileName, LPPROGRESS_ROUTINE lpProgressRoutine, LPVOID lpData, DWORD dwFlags, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall MoveFileTransactedW( LPCWSTR lpExistingFileName, LPCWSTR lpNewFileName, LPPROGRESS_ROUTINE lpProgressRoutine, LPVOID lpData, DWORD dwFlags, HANDLE hTransaction ); #line 5707 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Application Family #line 5722 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Desktop Family #pragma endregion #pragma region Application Family __declspec(dllimport) BOOL __stdcall ReplaceFileA( LPCSTR lpReplacedFileName, LPCSTR lpReplacementFileName, LPCSTR lpBackupFileName, DWORD dwReplaceFlags, LPVOID lpExclude, LPVOID lpReserved ); __declspec(dllimport) BOOL __stdcall ReplaceFileW( LPCWSTR lpReplacedFileName, LPCWSTR lpReplacementFileName, LPCWSTR lpBackupFileName, DWORD dwReplaceFlags, LPVOID lpExclude, LPVOID lpReserved ); #line 5766 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall CreateHardLinkA( LPCSTR lpFileName, LPCSTR lpExistingFileName, LPSECURITY_ATTRIBUTES lpSecurityAttributes ); __declspec(dllimport) BOOL __stdcall CreateHardLinkW( LPCWSTR lpFileName, LPCWSTR lpExistingFileName, LPSECURITY_ATTRIBUTES lpSecurityAttributes ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall CreateHardLinkTransactedA( LPCSTR lpFileName, LPCSTR lpExistingFileName, LPSECURITY_ATTRIBUTES lpSecurityAttributes, HANDLE hTransaction ); __declspec(dllimport) BOOL __stdcall CreateHardLinkTransactedW( LPCWSTR lpFileName, LPCWSTR lpExistingFileName, LPSECURITY_ATTRIBUTES lpSecurityAttributes, HANDLE hTransaction ); __declspec(dllimport) HANDLE __stdcall FindFirstStreamTransactedW ( LPCWSTR lpFileName, STREAM_INFO_LEVELS InfoLevel, LPVOID lpFindStreamData, DWORD dwFlags, HANDLE hTransaction ); __declspec(dllimport) HANDLE __stdcall FindFirstFileNameTransactedW ( LPCWSTR lpFileName, DWORD dwFlags, LPDWORD StringLength, PWSTR LinkName, HANDLE hTransaction ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) HANDLE __stdcall CreateNamedPipeA( LPCSTR lpName, DWORD dwOpenMode, DWORD dwPipeMode, DWORD nMaxInstances, DWORD nOutBufferSize, DWORD nInBufferSize, DWORD nDefaultTimeOut, LPSECURITY_ATTRIBUTES lpSecurityAttributes ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetNamedPipeHandleStateA( HANDLE hNamedPipe, LPDWORD lpState, LPDWORD lpCurInstances, LPDWORD lpMaxCollectionCount, LPDWORD lpCollectDataTimeout, LPSTR lpUserName, DWORD nMaxUserNameSize ); __declspec(dllimport) BOOL __stdcall CallNamedPipeA( LPCSTR lpNamedPipeName, LPVOID lpInBuffer, DWORD nInBufferSize, LPVOID lpOutBuffer, DWORD nOutBufferSize, LPDWORD lpBytesRead, DWORD nTimeOut ); __declspec(dllimport) BOOL __stdcall WaitNamedPipeA( LPCSTR lpNamedPipeName, DWORD nTimeOut ); #pragma endregion #pragma region Desktop Family #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetNamedPipeClientComputerNameA( HANDLE Pipe, LPSTR ClientComputerName, ULONG ClientComputerNameLength ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall GetNamedPipeClientProcessId( HANDLE Pipe, PULONG ClientProcessId ); __declspec(dllimport) BOOL __stdcall GetNamedPipeClientSessionId( HANDLE Pipe, PULONG ClientSessionId ); __declspec(dllimport) BOOL __stdcall GetNamedPipeServerProcessId( HANDLE Pipe, PULONG ServerProcessId ); __declspec(dllimport) BOOL __stdcall GetNamedPipeServerSessionId( HANDLE Pipe, PULONG ServerSessionId ); #pragma endregion #pragma region Application Family or Desktop Family __declspec(dllimport) BOOL __stdcall SetVolumeLabelA( LPCSTR lpRootPathName, LPCSTR lpVolumeName ); __declspec(dllimport) BOOL __stdcall SetVolumeLabelW( LPCWSTR lpRootPathName, LPCWSTR lpVolumeName ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall SetFileBandwidthReservation( HANDLE hFile, DWORD nPeriodMilliseconds, DWORD nBytesPerPeriod, BOOL bDiscardable, LPDWORD lpTransferSize, LPDWORD lpNumOutstandingRequests ); __declspec(dllimport) BOOL __stdcall GetFileBandwidthReservation( HANDLE hFile, LPDWORD lpPeriodMilliseconds, LPDWORD lpBytesPerPeriod, LPBOOL pDiscardable, LPDWORD lpTransferSize, LPDWORD lpNumOutstandingRequests ); __declspec(dllimport) BOOL __stdcall ClearEventLogA ( HANDLE hEventLog, LPCSTR lpBackupFileName ); __declspec(dllimport) BOOL __stdcall ClearEventLogW ( HANDLE hEventLog, LPCWSTR lpBackupFileName ); __declspec(dllimport) BOOL __stdcall BackupEventLogA ( HANDLE hEventLog, LPCSTR lpBackupFileName ); __declspec(dllimport) BOOL __stdcall BackupEventLogW ( HANDLE hEventLog, LPCWSTR lpBackupFileName ); __declspec(dllimport) BOOL __stdcall CloseEventLog ( HANDLE hEventLog ); __declspec(dllimport) BOOL __stdcall DeregisterEventSource ( HANDLE hEventLog ); __declspec(dllimport) BOOL __stdcall NotifyChangeEventLog( HANDLE hEventLog, HANDLE hEvent ); __declspec(dllimport) BOOL __stdcall GetNumberOfEventLogRecords ( HANDLE hEventLog, PDWORD NumberOfRecords ); __declspec(dllimport) BOOL __stdcall GetOldestEventLogRecord ( HANDLE hEventLog, PDWORD OldestRecord ); __declspec(dllimport) HANDLE __stdcall OpenEventLogA ( LPCSTR lpUNCServerName, LPCSTR lpSourceName ); __declspec(dllimport) HANDLE __stdcall OpenEventLogW ( LPCWSTR lpUNCServerName, LPCWSTR lpSourceName ); __declspec(dllimport) HANDLE __stdcall RegisterEventSourceA ( LPCSTR lpUNCServerName, LPCSTR lpSourceName ); __declspec(dllimport) HANDLE __stdcall RegisterEventSourceW ( LPCWSTR lpUNCServerName, LPCWSTR lpSourceName ); __declspec(dllimport) HANDLE __stdcall OpenBackupEventLogA ( LPCSTR lpUNCServerName, LPCSTR lpFileName ); __declspec(dllimport) HANDLE __stdcall OpenBackupEventLogW ( LPCWSTR lpUNCServerName, LPCWSTR lpFileName ); __declspec(dllimport) BOOL __stdcall ReadEventLogA ( HANDLE hEventLog, DWORD dwReadFlags, DWORD dwRecordOffset, LPVOID lpBuffer, DWORD nNumberOfBytesToRead, DWORD *pnBytesRead, DWORD *pnMinNumberOfBytesNeeded ); __declspec(dllimport) BOOL __stdcall ReadEventLogW ( HANDLE hEventLog, DWORD dwReadFlags, DWORD dwRecordOffset, LPVOID lpBuffer, DWORD nNumberOfBytesToRead, DWORD *pnBytesRead, DWORD *pnMinNumberOfBytesNeeded ); __declspec(dllimport) BOOL __stdcall ReportEventA ( HANDLE hEventLog, WORD wType, WORD wCategory, DWORD dwEventID, PSID lpUserSid, WORD wNumStrings, DWORD dwDataSize, LPCSTR *lpStrings, LPVOID lpRawData ); __declspec(dllimport) BOOL __stdcall ReportEventW ( HANDLE hEventLog, WORD wType, WORD wCategory, DWORD dwEventID, PSID lpUserSid, WORD wNumStrings, DWORD dwDataSize, LPCWSTR *lpStrings, LPVOID lpRawData ); typedef struct _EVENTLOG_FULL_INFORMATION { DWORD dwFull; } EVENTLOG_FULL_INFORMATION, *LPEVENTLOG_FULL_INFORMATION; __declspec(dllimport) BOOL __stdcall GetEventLogInformation ( HANDLE hEventLog, DWORD dwInfoLevel, LPVOID lpBuffer, DWORD cbBufSize, LPDWORD pcbBytesNeeded ); typedef ULONG OPERATION_ID; typedef struct _OPERATION_START_PARAMETERS { ULONG Version; OPERATION_ID OperationId; ULONG Flags; } OPERATION_START_PARAMETERS, *POPERATION_START_PARAMETERS; typedef struct _OPERATION_END_PARAMETERS { ULONG Version; OPERATION_ID OperationId; ULONG Flags; } OPERATION_END_PARAMETERS, *POPERATION_END_PARAMETERS; __declspec(dllimport) BOOL __stdcall OperationStart ( OPERATION_START_PARAMETERS* OperationStartParams ); __declspec(dllimport) BOOL __stdcall OperationEnd ( OPERATION_END_PARAMETERS* OperationEndParams ); __declspec(dllimport) BOOL __stdcall AccessCheckAndAuditAlarmA ( LPCSTR SubsystemName, LPVOID HandleId, LPSTR ObjectTypeName, LPSTR ObjectName, PSECURITY_DESCRIPTOR SecurityDescriptor, DWORD DesiredAccess, PGENERIC_MAPPING GenericMapping, BOOL ObjectCreation, LPDWORD GrantedAccess, LPBOOL AccessStatus, LPBOOL pfGenerateOnClose ); __declspec(dllimport) BOOL __stdcall AccessCheckByTypeAndAuditAlarmA ( LPCSTR SubsystemName, LPVOID HandleId, LPCSTR ObjectTypeName, LPCSTR ObjectName, PSECURITY_DESCRIPTOR SecurityDescriptor, PSID PrincipalSelfSid, DWORD DesiredAccess, AUDIT_EVENT_TYPE AuditType, DWORD Flags, POBJECT_TYPE_LIST ObjectTypeList, DWORD ObjectTypeListLength, PGENERIC_MAPPING GenericMapping, BOOL ObjectCreation, LPDWORD GrantedAccess, LPBOOL AccessStatus, LPBOOL pfGenerateOnClose ); __declspec(dllimport) BOOL __stdcall AccessCheckByTypeResultListAndAuditAlarmA ( LPCSTR SubsystemName, LPVOID HandleId, LPCSTR ObjectTypeName, LPCSTR ObjectName, PSECURITY_DESCRIPTOR SecurityDescriptor, PSID PrincipalSelfSid, DWORD DesiredAccess, AUDIT_EVENT_TYPE AuditType, DWORD Flags, POBJECT_TYPE_LIST ObjectTypeList, DWORD ObjectTypeListLength, PGENERIC_MAPPING GenericMapping, BOOL ObjectCreation, LPDWORD GrantedAccess, LPDWORD AccessStatusList, LPBOOL pfGenerateOnClose ); __declspec(dllimport) BOOL __stdcall AccessCheckByTypeResultListAndAuditAlarmByHandleA ( LPCSTR SubsystemName, LPVOID HandleId, HANDLE ClientToken, LPCSTR ObjectTypeName, LPCSTR ObjectName, PSECURITY_DESCRIPTOR SecurityDescriptor, PSID PrincipalSelfSid, DWORD DesiredAccess, AUDIT_EVENT_TYPE AuditType, DWORD Flags, POBJECT_TYPE_LIST ObjectTypeList, DWORD ObjectTypeListLength, PGENERIC_MAPPING GenericMapping, BOOL ObjectCreation, LPDWORD GrantedAccess, LPDWORD AccessStatusList, LPBOOL pfGenerateOnClose ); __declspec(dllimport) BOOL __stdcall ObjectOpenAuditAlarmA ( LPCSTR SubsystemName, LPVOID HandleId, LPSTR ObjectTypeName, LPSTR ObjectName, PSECURITY_DESCRIPTOR pSecurityDescriptor, HANDLE ClientToken, DWORD DesiredAccess, DWORD GrantedAccess, PPRIVILEGE_SET Privileges, BOOL ObjectCreation, BOOL AccessGranted, LPBOOL GenerateOnClose ); __declspec(dllimport) BOOL __stdcall ObjectPrivilegeAuditAlarmA ( LPCSTR SubsystemName, LPVOID HandleId, HANDLE ClientToken, DWORD DesiredAccess, PPRIVILEGE_SET Privileges, BOOL AccessGranted ); __declspec(dllimport) BOOL __stdcall ObjectCloseAuditAlarmA ( LPCSTR SubsystemName, LPVOID HandleId, BOOL GenerateOnClose ); __declspec(dllimport) BOOL __stdcall ObjectDeleteAuditAlarmA ( LPCSTR SubsystemName, LPVOID HandleId, BOOL GenerateOnClose ); __declspec(dllimport) BOOL __stdcall PrivilegedServiceAuditAlarmA ( LPCSTR SubsystemName, LPCSTR ServiceName, HANDLE ClientToken, PPRIVILEGE_SET Privileges, BOOL AccessGranted ); __declspec(dllimport) BOOL __stdcall AddConditionalAce ( PACL pAcl, DWORD dwAceRevision, DWORD AceFlags, UCHAR AceType, DWORD AccessMask, PSID pSid, PWCHAR ConditionStr, DWORD *ReturnLength ); #pragma endregion #pragma region Desktop Family or OneCore Family __declspec(dllimport) BOOL __stdcall SetFileSecurityA ( LPCSTR lpFileName, SECURITY_INFORMATION SecurityInformation, PSECURITY_DESCRIPTOR pSecurityDescriptor ); __declspec(dllimport) BOOL __stdcall GetFileSecurityA ( LPCSTR lpFileName, SECURITY_INFORMATION RequestedInformation, PSECURITY_DESCRIPTOR pSecurityDescriptor, DWORD nLength, LPDWORD lpnLengthNeeded ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall ReadDirectoryChangesW( HANDLE hDirectory, LPVOID lpBuffer, DWORD nBufferLength, BOOL bWatchSubtree, DWORD dwNotifyFilter, LPDWORD lpBytesReturned, LPOVERLAPPED lpOverlapped, LPOVERLAPPED_COMPLETION_ROUTINE lpCompletionRoutine ); __declspec(dllimport) BOOL __stdcall ReadDirectoryChangesExW( HANDLE hDirectory, LPVOID lpBuffer, DWORD nBufferLength, BOOL bWatchSubtree, DWORD dwNotifyFilter, LPDWORD lpBytesReturned, LPOVERLAPPED lpOverlapped, LPOVERLAPPED_COMPLETION_ROUTINE lpCompletionRoutine, READ_DIRECTORY_NOTIFY_INFORMATION_CLASS ReadDirectoryNotifyInformationClass ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) LPVOID __stdcall MapViewOfFileExNuma( HANDLE hFileMappingObject, DWORD dwDesiredAccess, DWORD dwFileOffsetHigh, DWORD dwFileOffsetLow, SIZE_T dwNumberOfBytesToMap, LPVOID lpBaseAddress, DWORD nndPreferred ); __declspec(dllimport) BOOL __stdcall IsBadReadPtr( const void *lp, UINT_PTR ucb ); __declspec(dllimport) BOOL __stdcall IsBadWritePtr( LPVOID lp, UINT_PTR ucb ); __declspec(dllimport) BOOL __stdcall IsBadHugeReadPtr( const void *lp, UINT_PTR ucb ); __declspec(dllimport) BOOL __stdcall IsBadHugeWritePtr( LPVOID lp, UINT_PTR ucb ); __declspec(dllimport) BOOL __stdcall IsBadCodePtr( FARPROC lpfn ); __declspec(dllimport) BOOL __stdcall IsBadStringPtrA( LPCSTR lpsz, UINT_PTR ucchMax ); __declspec(dllimport) BOOL __stdcall IsBadStringPtrW( LPCWSTR lpsz, UINT_PTR ucchMax ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall LookupAccountSidA( LPCSTR lpSystemName, PSID Sid, LPSTR Name, LPDWORD cchName, LPSTR ReferencedDomainName, LPDWORD cchReferencedDomainName, PSID_NAME_USE peUse ); __declspec(dllimport) BOOL __stdcall LookupAccountSidW( LPCWSTR lpSystemName, PSID Sid, LPWSTR Name, LPDWORD cchName, LPWSTR ReferencedDomainName, LPDWORD cchReferencedDomainName, PSID_NAME_USE peUse ); __declspec(dllimport) BOOL __stdcall LookupAccountNameA( LPCSTR lpSystemName, LPCSTR lpAccountName, PSID Sid, LPDWORD cbSid, LPSTR ReferencedDomainName, LPDWORD cchReferencedDomainName, PSID_NAME_USE peUse ); __declspec(dllimport) BOOL __stdcall LookupAccountNameW( LPCWSTR lpSystemName, LPCWSTR lpAccountName, PSID Sid, LPDWORD cbSid, LPWSTR ReferencedDomainName, LPDWORD cchReferencedDomainName, PSID_NAME_USE peUse ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall LookupAccountNameLocalA( LPCSTR lpAccountName, PSID Sid, LPDWORD cbSid, LPSTR ReferencedDomainName, LPDWORD cchReferencedDomainName, PSID_NAME_USE peUse ); __declspec(dllimport) BOOL __stdcall LookupAccountNameLocalW( LPCWSTR lpAccountName, PSID Sid, LPDWORD cbSid, LPWSTR ReferencedDomainName, LPDWORD cchReferencedDomainName, PSID_NAME_USE peUse ); __declspec(dllimport) BOOL __stdcall LookupAccountSidLocalA( PSID Sid, LPSTR Name, LPDWORD cchName, LPSTR ReferencedDomainName, LPDWORD cchReferencedDomainName, PSID_NAME_USE peUse ); __declspec(dllimport) BOOL __stdcall LookupAccountSidLocalW( PSID Sid, LPWSTR Name, LPDWORD cchName, LPWSTR ReferencedDomainName, LPDWORD cchReferencedDomainName, PSID_NAME_USE peUse ); #line 6844 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall LookupPrivilegeValueA( LPCSTR lpSystemName, LPCSTR lpName, PLUID lpLuid ); __declspec(dllimport) BOOL __stdcall LookupPrivilegeValueW( LPCWSTR lpSystemName, LPCWSTR lpName, PLUID lpLuid ); __declspec(dllimport) BOOL __stdcall LookupPrivilegeNameA( LPCSTR lpSystemName, PLUID lpLuid, LPSTR lpName, LPDWORD cchName ); __declspec(dllimport) BOOL __stdcall LookupPrivilegeNameW( LPCWSTR lpSystemName, PLUID lpLuid, LPWSTR lpName, LPDWORD cchName ); __declspec(dllimport) BOOL __stdcall LookupPrivilegeDisplayNameA( LPCSTR lpSystemName, LPCSTR lpName, LPSTR lpDisplayName, LPDWORD cchDisplayName, LPDWORD lpLanguageId ); __declspec(dllimport) BOOL __stdcall LookupPrivilegeDisplayNameW( LPCWSTR lpSystemName, LPCWSTR lpName, LPWSTR lpDisplayName, LPDWORD cchDisplayName, LPDWORD lpLanguageId ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall BuildCommDCBA( LPCSTR lpDef, LPDCB lpDCB ); __declspec(dllimport) BOOL __stdcall BuildCommDCBW( LPCWSTR lpDef, LPDCB lpDCB ); __declspec(dllimport) BOOL __stdcall BuildCommDCBAndTimeoutsA( LPCSTR lpDef, LPDCB lpDCB, LPCOMMTIMEOUTS lpCommTimeouts ); __declspec(dllimport) BOOL __stdcall BuildCommDCBAndTimeoutsW( LPCWSTR lpDef, LPDCB lpDCB, LPCOMMTIMEOUTS lpCommTimeouts ); __declspec(dllimport) BOOL __stdcall CommConfigDialogA( LPCSTR lpszName, HWND hWnd, LPCOMMCONFIG lpCC ); __declspec(dllimport) BOOL __stdcall CommConfigDialogW( LPCWSTR lpszName, HWND hWnd, LPCOMMCONFIG lpCC ); __declspec(dllimport) BOOL __stdcall GetDefaultCommConfigA( LPCSTR lpszName, LPCOMMCONFIG lpCC, LPDWORD lpdwSize ); __declspec(dllimport) BOOL __stdcall GetDefaultCommConfigW( LPCWSTR lpszName, LPCOMMCONFIG lpCC, LPDWORD lpdwSize ); __declspec(dllimport) BOOL __stdcall SetDefaultCommConfigA( LPCSTR lpszName, LPCOMMCONFIG lpCC, DWORD dwSize ); __declspec(dllimport) BOOL __stdcall SetDefaultCommConfigW( LPCWSTR lpszName, LPCOMMCONFIG lpCC, DWORD dwSize ); #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) BOOL __stdcall GetComputerNameA ( LPSTR lpBuffer, LPDWORD nSize ); __declspec(dllimport) BOOL __stdcall GetComputerNameW ( LPWSTR lpBuffer, LPDWORD nSize ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall DnsHostnameToComputerNameA ( LPCSTR Hostname, LPSTR ComputerName, LPDWORD nSize ); __declspec(dllimport) BOOL __stdcall DnsHostnameToComputerNameW ( LPCWSTR Hostname, LPWSTR ComputerName, LPDWORD nSize ); __declspec(dllimport) BOOL __stdcall GetUserNameA ( LPSTR lpBuffer, LPDWORD pcbBuffer ); __declspec(dllimport) BOOL __stdcall GetUserNameW ( LPWSTR lpBuffer, LPDWORD pcbBuffer ); #line 7139 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" #line 7151 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) BOOL __stdcall LogonUserA ( LPCSTR lpszUsername, LPCSTR lpszDomain, LPCSTR lpszPassword, DWORD dwLogonType, DWORD dwLogonProvider, PHANDLE phToken ); __declspec(dllimport) BOOL __stdcall LogonUserW ( LPCWSTR lpszUsername, LPCWSTR lpszDomain, LPCWSTR lpszPassword, DWORD dwLogonType, DWORD dwLogonProvider, PHANDLE phToken ); __declspec(dllimport) BOOL __stdcall LogonUserExA ( LPCSTR lpszUsername, LPCSTR lpszDomain, LPCSTR lpszPassword, DWORD dwLogonType, DWORD dwLogonProvider, PHANDLE phToken, PSID *ppLogonSid, PVOID *ppProfileBuffer, LPDWORD pdwProfileLength, PQUOTA_LIMITS pQuotaLimits ); __declspec(dllimport) BOOL __stdcall LogonUserExW ( LPCWSTR lpszUsername, LPCWSTR lpszDomain, LPCWSTR lpszPassword, DWORD dwLogonType, DWORD dwLogonProvider, PHANDLE phToken, PSID *ppLogonSid, PVOID *ppProfileBuffer, LPDWORD pdwProfileLength, PQUOTA_LIMITS pQuotaLimits ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall CreateProcessWithLogonW( LPCWSTR lpUsername, LPCWSTR lpDomain, LPCWSTR lpPassword, DWORD dwLogonFlags, LPCWSTR lpApplicationName, LPWSTR lpCommandLine, DWORD dwCreationFlags, LPVOID lpEnvironment, LPCWSTR lpCurrentDirectory, LPSTARTUPINFOW lpStartupInfo, LPPROCESS_INFORMATION lpProcessInformation ); __declspec(dllimport) BOOL __stdcall CreateProcessWithTokenW( HANDLE hToken, DWORD dwLogonFlags, LPCWSTR lpApplicationName, LPWSTR lpCommandLine, DWORD dwCreationFlags, LPVOID lpEnvironment, LPCWSTR lpCurrentDirectory, LPSTARTUPINFOW lpStartupInfo, LPPROCESS_INFORMATION lpProcessInformation ); __declspec(dllimport) BOOL __stdcall IsTokenUntrusted( HANDLE TokenHandle ); __declspec(dllimport) BOOL __stdcall RegisterWaitForSingleObject( PHANDLE phNewWaitObject, HANDLE hObject, WAITORTIMERCALLBACK Callback, PVOID Context, ULONG dwMilliseconds, ULONG dwFlags ); __declspec(dllimport) BOOL __stdcall UnregisterWait( HANDLE WaitHandle ); __declspec(dllimport) BOOL __stdcall BindIoCompletionCallback ( HANDLE FileHandle, LPOVERLAPPED_COMPLETION_ROUTINE Function, ULONG Flags ); __declspec(dllimport) HANDLE __stdcall SetTimerQueueTimer( HANDLE TimerQueue, WAITORTIMERCALLBACK Callback, PVOID Parameter, DWORD DueTime, DWORD Period, BOOL PreferIo ); __declspec(dllimport) BOOL __stdcall CancelTimerQueueTimer( HANDLE TimerQueue, HANDLE Timer ); __declspec(dllimport) BOOL __stdcall DeleteTimerQueue( HANDLE TimerQueue ); __forceinline void InitializeThreadpoolEnvironment( PTP_CALLBACK_ENVIRON pcbe ) { TpInitializeCallbackEnviron(pcbe); } __forceinline void SetThreadpoolCallbackPool( PTP_CALLBACK_ENVIRON pcbe, PTP_POOL ptpp ) { TpSetCallbackThreadpool(pcbe, ptpp); } __forceinline void SetThreadpoolCallbackCleanupGroup( PTP_CALLBACK_ENVIRON pcbe, PTP_CLEANUP_GROUP ptpcg, PTP_CLEANUP_GROUP_CANCEL_CALLBACK pfng ) { TpSetCallbackCleanupGroup(pcbe, ptpcg, pfng); } __forceinline void SetThreadpoolCallbackRunsLong( PTP_CALLBACK_ENVIRON pcbe ) { TpSetCallbackLongFunction(pcbe); } __forceinline void SetThreadpoolCallbackLibrary( PTP_CALLBACK_ENVIRON pcbe, PVOID mod ) { TpSetCallbackRaceWithDll(pcbe, mod); } __forceinline void SetThreadpoolCallbackPriority( PTP_CALLBACK_ENVIRON pcbe, TP_CALLBACK_PRIORITY Priority ) { TpSetCallbackPriority(pcbe, Priority); } __forceinline void DestroyThreadpoolEnvironment( PTP_CALLBACK_ENVIRON pcbe ) { TpDestroyCallbackEnviron(pcbe); } #pragma region Desktop Family __forceinline void SetThreadpoolCallbackPersistent( PTP_CALLBACK_ENVIRON pcbe ) { TpSetCallbackPersistent(pcbe); } #pragma endregion #pragma region Application Family or OneCore Family __declspec(dllimport) HANDLE __stdcall CreatePrivateNamespaceA( LPSECURITY_ATTRIBUTES lpPrivateNamespaceAttributes, LPVOID lpBoundaryDescriptor, LPCSTR lpAliasPrefix ); __declspec(dllimport) HANDLE __stdcall OpenPrivateNamespaceA( LPVOID lpBoundaryDescriptor, LPCSTR lpAliasPrefix ); __declspec(dllimport) HANDLE __stdcall CreateBoundaryDescriptorA( LPCSTR Name, ULONG Flags ); #pragma endregion #pragma region Desktop Family __declspec(dllimport) BOOL __stdcall AddIntegrityLabelToBoundaryDescriptor( HANDLE * BoundaryDescriptor, PSID IntegrityLabel ); #pragma endregion #pragma region Desktop Family typedef struct tagHW_PROFILE_INFOA { DWORD dwDockInfo; CHAR szHwProfileGuid[39]; CHAR szHwProfileName[80]; } HW_PROFILE_INFOA, *LPHW_PROFILE_INFOA; typedef struct tagHW_PROFILE_INFOW { DWORD dwDockInfo; WCHAR szHwProfileGuid[39]; WCHAR szHwProfileName[80]; } HW_PROFILE_INFOW, *LPHW_PROFILE_INFOW; typedef HW_PROFILE_INFOA HW_PROFILE_INFO; typedef LPHW_PROFILE_INFOA LPHW_PROFILE_INFO; __declspec(dllimport) BOOL __stdcall GetCurrentHwProfileA ( LPHW_PROFILE_INFOA lpHwProfileInfo ); __declspec(dllimport) BOOL __stdcall GetCurrentHwProfileW ( LPHW_PROFILE_INFOW lpHwProfileInfo ); #line 7588 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\um\\winbase.h" __declspec(dllimport) BOOL __stdcall VerifyVersionInfoA( LPOSVERSIONINFOEXA lpVersionInformation, DWORD dwTypeMask, DWORDLONG dwlConditionMask ); __declspec(dllimport) BOOL __stdcall VerifyVersionInfoW( LPOSVERSIONINFOEXW lpVersionInformation, DWORD dwTypeMask, DWORDLONG dwlConditionMask ); #pragma endregion #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winerror.h" #pragma once #line 23 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winerror.h" #line 202 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winerror.h" __forceinline HRESULT HRESULT_FROM_WIN32(unsigned long x) { return (HRESULT)(x) <= 0 ? (HRESULT)(x) : (HRESULT) (((x) & 0x0000FFFF) | (7 << 16) | 0x80000000);} #line 28738 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winerror.h" #line 29723 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winerror.h" #line 30012 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winerror.h" #line 45990 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winerror.h" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_WS2TCPIP_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: endian.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "endian.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "endian.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: immintrin.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\wmmintrin.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\nmmintrin.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\smmintrin.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\tmmintrin.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\pmmintrin.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\emmintrin.h" #line 33 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\emmintrin.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\mmintrin.h" #line 46 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\mmintrin.h" #line 54 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\mmintrin.h" #line 82 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\mmintrin.h" typedef union __declspec(align(8)) __declspec(intrin_type) __m64 { unsigned __int64 m64_u64; float m64_f32[2]; __int8 m64_i8[8]; __int16 m64_i16[4]; __int32 m64_i32[2]; __int64 m64_i64; unsigned __int8 m64_u8[8]; unsigned __int16 m64_u16[4]; unsigned __int32 m64_u32[2]; __int64 __m; } __m64; #line 197 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\mmintrin.h" #line 256 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\mmintrin.h" #line 25 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 32 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" typedef union __declspec(align(16)) __declspec(intrin_type) __m128 { float m128_f32[4]; unsigned __int64 m128_u64[2]; __int8 m128_i8[16]; __int16 m128_i16[8]; __int32 m128_i32[4]; __int64 m128_i64[2]; unsigned __int8 m128_u8[16]; unsigned __int16 m128_u16[8]; unsigned __int32 m128_u32[4]; float f[4]; } __m128; #line 66 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" #pragma once __pragma(pack(push, 8)) #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __declspec(allocator) __declspec(restrict) void* __cdecl _calloc_base( size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl calloc( size_t _Count, size_t _Size ); int __cdecl _callnewh( size_t _Size ); __declspec(allocator) void* __cdecl _expand( void* _Block, size_t _Size ); void __cdecl _free_base( void* _Block ); void __cdecl free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _malloc_base( size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl malloc( size_t _Size ); size_t __cdecl _msize_base( void* _Block ); size_t __cdecl _msize( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _realloc_base( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl realloc( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc_base( void* _Block, size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc( void* _Block, size_t _Count, size_t _Size ); void __cdecl _aligned_free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_malloc( size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_malloc( size_t _Size, size_t _Alignment, size_t _Offset ); size_t __cdecl _aligned_msize( void* _Block, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_realloc( void* _Block, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_realloc( void* _Block, size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment ); #line 225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" __pragma(pack(push, 8)) #line 37 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" typedef struct _heapinfo { int* _pentry; size_t _size; int _useflag; } _HEAPINFO; void* __cdecl _alloca( size_t _Size); intptr_t __cdecl _get_heap_handle(void); int __cdecl _heapmin(void); int __cdecl _heapwalk( _HEAPINFO* _EntryInfo); int __cdecl _heapchk(void); int __cdecl _resetstkoflw(void); typedef char __static_assert_t[(sizeof(unsigned int) <= 16) != 0]; #pragma warning(push) #pragma warning(disable:6540) __inline void* _MarkAllocaS( void* _Ptr, unsigned int _Marker) { if (_Ptr) { *((unsigned int*)_Ptr) = _Marker; _Ptr = (char*)_Ptr + 16; } return _Ptr; } __inline size_t _MallocaComputeSize(size_t _Size) { size_t _MarkedSize = _Size + 16; return _MarkedSize > _Size ? _MarkedSize : 0; } #pragma warning(pop) #line 126 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" #line 135 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" #pragma warning(push) #pragma warning(disable: 6014) __inline void __cdecl _freea( void* _Memory) { unsigned int _Marker; if (_Memory) { _Memory = (char*)_Memory - 16; _Marker = *(unsigned int*)_Memory; if (_Marker == 0xDDDD) { free(_Memory); } #line 165 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\malloc.h" } } #pragma warning(pop) __pragma(pack(pop)) #line 73 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 123 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 134 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 143 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 151 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 343 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 367 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 390 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 407 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\xmmintrin.h" #line 40 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\emmintrin.h" typedef struct __declspec(align(16)) __declspec(intrin_type) __m128d { double m128d_f64[2]; } __m128d; typedef union __declspec(align(16)) __declspec(intrin_type) __m128i { #line 56 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\emmintrin.h" __int8 m128i_i8[16]; __int16 m128i_i16[8]; __int32 m128i_i32[4]; __int64 m128i_i64[2]; unsigned __int8 m128i_u8[16]; unsigned __int16 m128i_u16[8]; unsigned __int32 m128i_u32[4]; unsigned __int64 m128i_u64[2]; char c[16]; } __m128i; #line 434 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\emmintrin.h" #line 22 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\pmmintrin.h" #line 75 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\pmmintrin.h" extern void __cdecl _mm_monitor(void const *, unsigned, unsigned); extern void __cdecl _mm_mwait(unsigned, unsigned); #line 15 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\tmmintrin.h" #line 97 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\tmmintrin.h" #line 24 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\smmintrin.h" #line 45 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\smmintrin.h" #line 165 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\smmintrin.h" #line 179 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\smmintrin.h" #line 279 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\smmintrin.h" #line 25 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\nmmintrin.h" #line 137 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\nmmintrin.h" #line 24 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\wmmintrin.h" #line 79 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\wmmintrin.h" #line 15 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 31 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" typedef union __declspec(align(32)) __declspec(intrin_type) __m256 { float m256_f32[8]; } __m256; typedef struct __declspec(align(32)) __declspec(intrin_type) __m256d { double m256d_f64[4]; } __m256d; typedef union __declspec(align(32)) __declspec(intrin_type) __m256i { #line 47 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" __int8 m256i_i8[32]; __int16 m256i_i16[16]; __int32 m256i_i32[8]; __int64 m256i_i64[4]; unsigned __int8 m256i_u8[32]; unsigned __int16 m256i_u16[16]; unsigned __int32 m256i_u32[8]; unsigned __int64 m256i_u64[4]; } __m256i; #line 80 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 121 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" extern void __cdecl _allow_cpu_features(unsigned __int64); extern int __cdecl _may_i_use_cpu_feature(unsigned __int64); #line 181 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" extern __int64 __cdecl _rdtsc(void); extern __int64 __cdecl _rdpmc(int); extern int __cdecl _bswap(int); extern int __cdecl _bit_scan_forward(int); extern int __cdecl _bit_scan_reverse(int); #line 223 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" extern int __cdecl _popcnt32(int); extern unsigned short __cdecl _rotwl(unsigned short, int); extern unsigned short __cdecl _rotwr(unsigned short, int); extern unsigned int __cdecl _rotl(unsigned int, int); extern unsigned int __cdecl _rotr(unsigned int, int); extern unsigned long __cdecl _lrotl(unsigned long, int); extern unsigned long __cdecl _lrotr(unsigned long, int); extern unsigned __int64 __cdecl _rotl64(unsigned __int64, int); extern unsigned __int64 __cdecl _rotr64(unsigned __int64, int); #line 456 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 475 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 489 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 508 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 531 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 1206 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 1242 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 1250 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 1258 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 1420 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 1437 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 1567 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 1601 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 1702 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 2288 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" extern unsigned int __cdecl _bextr_u32(unsigned int, unsigned int, unsigned int); extern unsigned int __cdecl _bextr2_u32(unsigned int, unsigned int); extern unsigned int __cdecl _blsi_u32(unsigned int); extern unsigned int __cdecl _blsmsk_u32(unsigned int); extern unsigned int __cdecl _blsr_u32(unsigned int); extern unsigned int __cdecl _bzhi_u32(unsigned int, unsigned int); extern unsigned int __cdecl _pext_u32(unsigned int, unsigned int); extern unsigned int __cdecl _pdep_u32(unsigned int, unsigned int); extern unsigned int __cdecl _andn_u32(unsigned int, unsigned int); #line 2315 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" extern unsigned __int64 __cdecl _bextr_u64(unsigned __int64, unsigned int, unsigned int); extern unsigned __int64 __cdecl _bextr2_u64(unsigned __int64, unsigned __int64); extern unsigned __int64 __cdecl _blsi_u64(unsigned __int64); extern unsigned __int64 __cdecl _blsmsk_u64(unsigned __int64); extern unsigned __int64 __cdecl _blsr_u64(unsigned __int64); extern unsigned __int64 __cdecl _bzhi_u64(unsigned __int64, unsigned int); extern unsigned __int64 __cdecl _pext_u64(unsigned __int64, unsigned __int64); extern unsigned __int64 __cdecl _pdep_u64(unsigned __int64, unsigned __int64); extern unsigned __int64 __cdecl _andn_u64(unsigned __int64, unsigned __int64); #line 2341 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" extern unsigned int __cdecl _lzcnt_u32(unsigned int); extern unsigned __int64 __cdecl _lzcnt_u64(unsigned __int64); extern unsigned int __cdecl _tzcnt_u32(unsigned int); extern unsigned __int64 __cdecl _tzcnt_u64(unsigned __int64); extern void __cdecl _invpcid(unsigned int , void * ); #line 2385 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" extern unsigned int __cdecl _xbegin(void); extern void __cdecl _xend(void); extern void __cdecl _xabort(const unsigned int); extern unsigned char __cdecl _xtest(void); extern int __cdecl _rdseed16_step(unsigned short *); extern int __cdecl _rdseed32_step(unsigned int *); extern int __cdecl _rdseed64_step(unsigned __int64 *); extern unsigned char __cdecl _addcarry_u32(unsigned char , unsigned int , unsigned int , unsigned int * ); extern unsigned char __cdecl _addcarry_u64(unsigned char , unsigned __int64 , unsigned __int64 , unsigned __int64 * ); extern unsigned char __cdecl _subborrow_u32(unsigned char , unsigned int , unsigned int , unsigned int * ); extern unsigned char __cdecl _subborrow_u64(unsigned char , unsigned __int64 , unsigned __int64 , unsigned __int64 * ); extern unsigned char __cdecl _addcarryx_u32(unsigned char , unsigned int , unsigned int , unsigned int * ); extern unsigned char __cdecl _addcarryx_u64(unsigned char , unsigned __int64 , unsigned __int64 , unsigned __int64 * ); #line 2502 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" extern void * __cdecl _bnd_set_ptr_bounds(const void *, size_t); extern void * __cdecl _bnd_narrow_ptr_bounds(const void *, const void *, size_t); extern void * __cdecl _bnd_copy_ptr_bounds(const void *, const void *); extern void * __cdecl _bnd_init_ptr_bounds(const void *); extern void __cdecl _bnd_store_ptr_bounds(const void **, const void *); extern void __cdecl _bnd_chk_ptr_lbounds(const void *); extern void __cdecl _bnd_chk_ptr_ubounds(const void *); extern void __cdecl _bnd_chk_ptr_bounds(const void *, size_t); extern const void * __cdecl _bnd_get_ptr_lbound(const void *); extern const void * __cdecl _bnd_get_ptr_ubound(const void *); #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" typedef unsigned char __mmask8; typedef unsigned short __mmask16; typedef unsigned int __mmask32; typedef unsigned __int64 __mmask64; typedef __mmask16 __mmask; #line 61 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" typedef union __declspec(align(64)) __declspec(intrin_type) __m512 { float __m512_f32[16]; } __m512; typedef union __declspec(align(64)) __declspec(intrin_type) __m512d { double __m512d_f64[8]; } __m512d; typedef union __declspec(align(64)) __declspec(intrin_type) __m512i { #line 78 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" __int8 m512i_i8[64]; __int16 m512i_i16[32]; __int32 m512i_i32[16]; __int64 m512i_i64[8]; unsigned __int8 m512i_u8[64]; unsigned __int16 m512i_u16[32]; unsigned __int32 m512i_u32[16]; unsigned __int64 m512i_u64[8]; int __m512i_i32[16]; } __m512i; #line 106 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" typedef enum { _MM_SWIZ_REG_NONE, _MM_SWIZ_REG_CDAB, _MM_SWIZ_REG_BADC, _MM_SWIZ_REG_AAAA, _MM_SWIZ_REG_BBBB, _MM_SWIZ_REG_CCCC, _MM_SWIZ_REG_DDDD, _MM_SWIZ_REG_DACB } _MM_SWIZZLE_ENUM; typedef enum { _MM_BROADCAST32_NONE, _MM_BROADCAST_1X16, _MM_BROADCAST_4X16 } _MM_BROADCAST32_ENUM; typedef enum { _MM_BROADCAST64_NONE, _MM_BROADCAST_1X8, _MM_BROADCAST_4X8 } _MM_BROADCAST64_ENUM; typedef enum { _MM_ROUND_MODE_NEAREST, _MM_ROUND_MODE_DOWN, _MM_ROUND_MODE_UP, _MM_ROUND_MODE_TOWARD_ZERO, _MM_ROUND_MODE_DEFAULT } _MM_ROUND_MODE_ENUM; typedef enum { _MM_EXPADJ_NONE, _MM_EXPADJ_4, _MM_EXPADJ_5, _MM_EXPADJ_8, _MM_EXPADJ_16, _MM_EXPADJ_24, _MM_EXPADJ_31, _MM_EXPADJ_32 } _MM_EXP_ADJ_ENUM; typedef enum { _MM_SCALE_1 = 1, _MM_SCALE_2 = 2, _MM_SCALE_4 = 4, _MM_SCALE_8 = 8 } _MM_INDEX_SCALE_ENUM; typedef enum { _MM_PERM_AAAA = 0x00, _MM_PERM_AAAB = 0x01, _MM_PERM_AAAC = 0x02, _MM_PERM_AAAD = 0x03, _MM_PERM_AABA = 0x04, _MM_PERM_AABB = 0x05, _MM_PERM_AABC = 0x06, _MM_PERM_AABD = 0x07, _MM_PERM_AACA = 0x08, _MM_PERM_AACB = 0x09, _MM_PERM_AACC = 0x0A, _MM_PERM_AACD = 0x0B, _MM_PERM_AADA = 0x0C, _MM_PERM_AADB = 0x0D, _MM_PERM_AADC = 0x0E, _MM_PERM_AADD = 0x0F, _MM_PERM_ABAA = 0x10, _MM_PERM_ABAB = 0x11, _MM_PERM_ABAC = 0x12, _MM_PERM_ABAD = 0x13, _MM_PERM_ABBA = 0x14, _MM_PERM_ABBB = 0x15, _MM_PERM_ABBC = 0x16, _MM_PERM_ABBD = 0x17, _MM_PERM_ABCA = 0x18, _MM_PERM_ABCB = 0x19, _MM_PERM_ABCC = 0x1A, _MM_PERM_ABCD = 0x1B, _MM_PERM_ABDA = 0x1C, _MM_PERM_ABDB = 0x1D, _MM_PERM_ABDC = 0x1E, _MM_PERM_ABDD = 0x1F, _MM_PERM_ACAA = 0x20, _MM_PERM_ACAB = 0x21, _MM_PERM_ACAC = 0x22, _MM_PERM_ACAD = 0x23, _MM_PERM_ACBA = 0x24, _MM_PERM_ACBB = 0x25, _MM_PERM_ACBC = 0x26, _MM_PERM_ACBD = 0x27, _MM_PERM_ACCA = 0x28, _MM_PERM_ACCB = 0x29, _MM_PERM_ACCC = 0x2A, _MM_PERM_ACCD = 0x2B, _MM_PERM_ACDA = 0x2C, _MM_PERM_ACDB = 0x2D, _MM_PERM_ACDC = 0x2E, _MM_PERM_ACDD = 0x2F, _MM_PERM_ADAA = 0x30, _MM_PERM_ADAB = 0x31, _MM_PERM_ADAC = 0x32, _MM_PERM_ADAD = 0x33, _MM_PERM_ADBA = 0x34, _MM_PERM_ADBB = 0x35, _MM_PERM_ADBC = 0x36, _MM_PERM_ADBD = 0x37, _MM_PERM_ADCA = 0x38, _MM_PERM_ADCB = 0x39, _MM_PERM_ADCC = 0x3A, _MM_PERM_ADCD = 0x3B, _MM_PERM_ADDA = 0x3C, _MM_PERM_ADDB = 0x3D, _MM_PERM_ADDC = 0x3E, _MM_PERM_ADDD = 0x3F, _MM_PERM_BAAA = 0x40, _MM_PERM_BAAB = 0x41, _MM_PERM_BAAC = 0x42, _MM_PERM_BAAD = 0x43, _MM_PERM_BABA = 0x44, _MM_PERM_BABB = 0x45, _MM_PERM_BABC = 0x46, _MM_PERM_BABD = 0x47, _MM_PERM_BACA = 0x48, _MM_PERM_BACB = 0x49, _MM_PERM_BACC = 0x4A, _MM_PERM_BACD = 0x4B, _MM_PERM_BADA = 0x4C, _MM_PERM_BADB = 0x4D, _MM_PERM_BADC = 0x4E, _MM_PERM_BADD = 0x4F, _MM_PERM_BBAA = 0x50, _MM_PERM_BBAB = 0x51, _MM_PERM_BBAC = 0x52, _MM_PERM_BBAD = 0x53, _MM_PERM_BBBA = 0x54, _MM_PERM_BBBB = 0x55, _MM_PERM_BBBC = 0x56, _MM_PERM_BBBD = 0x57, _MM_PERM_BBCA = 0x58, _MM_PERM_BBCB = 0x59, _MM_PERM_BBCC = 0x5A, _MM_PERM_BBCD = 0x5B, _MM_PERM_BBDA = 0x5C, _MM_PERM_BBDB = 0x5D, _MM_PERM_BBDC = 0x5E, _MM_PERM_BBDD = 0x5F, _MM_PERM_BCAA = 0x60, _MM_PERM_BCAB = 0x61, _MM_PERM_BCAC = 0x62, _MM_PERM_BCAD = 0x63, _MM_PERM_BCBA = 0x64, _MM_PERM_BCBB = 0x65, _MM_PERM_BCBC = 0x66, _MM_PERM_BCBD = 0x67, _MM_PERM_BCCA = 0x68, _MM_PERM_BCCB = 0x69, _MM_PERM_BCCC = 0x6A, _MM_PERM_BCCD = 0x6B, _MM_PERM_BCDA = 0x6C, _MM_PERM_BCDB = 0x6D, _MM_PERM_BCDC = 0x6E, _MM_PERM_BCDD = 0x6F, _MM_PERM_BDAA = 0x70, _MM_PERM_BDAB = 0x71, _MM_PERM_BDAC = 0x72, _MM_PERM_BDAD = 0x73, _MM_PERM_BDBA = 0x74, _MM_PERM_BDBB = 0x75, _MM_PERM_BDBC = 0x76, _MM_PERM_BDBD = 0x77, _MM_PERM_BDCA = 0x78, _MM_PERM_BDCB = 0x79, _MM_PERM_BDCC = 0x7A, _MM_PERM_BDCD = 0x7B, _MM_PERM_BDDA = 0x7C, _MM_PERM_BDDB = 0x7D, _MM_PERM_BDDC = 0x7E, _MM_PERM_BDDD = 0x7F, _MM_PERM_CAAA = 0x80, _MM_PERM_CAAB = 0x81, _MM_PERM_CAAC = 0x82, _MM_PERM_CAAD = 0x83, _MM_PERM_CABA = 0x84, _MM_PERM_CABB = 0x85, _MM_PERM_CABC = 0x86, _MM_PERM_CABD = 0x87, _MM_PERM_CACA = 0x88, _MM_PERM_CACB = 0x89, _MM_PERM_CACC = 0x8A, _MM_PERM_CACD = 0x8B, _MM_PERM_CADA = 0x8C, _MM_PERM_CADB = 0x8D, _MM_PERM_CADC = 0x8E, _MM_PERM_CADD = 0x8F, _MM_PERM_CBAA = 0x90, _MM_PERM_CBAB = 0x91, _MM_PERM_CBAC = 0x92, _MM_PERM_CBAD = 0x93, _MM_PERM_CBBA = 0x94, _MM_PERM_CBBB = 0x95, _MM_PERM_CBBC = 0x96, _MM_PERM_CBBD = 0x97, _MM_PERM_CBCA = 0x98, _MM_PERM_CBCB = 0x99, _MM_PERM_CBCC = 0x9A, _MM_PERM_CBCD = 0x9B, _MM_PERM_CBDA = 0x9C, _MM_PERM_CBDB = 0x9D, _MM_PERM_CBDC = 0x9E, _MM_PERM_CBDD = 0x9F, _MM_PERM_CCAA = 0xA0, _MM_PERM_CCAB = 0xA1, _MM_PERM_CCAC = 0xA2, _MM_PERM_CCAD = 0xA3, _MM_PERM_CCBA = 0xA4, _MM_PERM_CCBB = 0xA5, _MM_PERM_CCBC = 0xA6, _MM_PERM_CCBD = 0xA7, _MM_PERM_CCCA = 0xA8, _MM_PERM_CCCB = 0xA9, _MM_PERM_CCCC = 0xAA, _MM_PERM_CCCD = 0xAB, _MM_PERM_CCDA = 0xAC, _MM_PERM_CCDB = 0xAD, _MM_PERM_CCDC = 0xAE, _MM_PERM_CCDD = 0xAF, _MM_PERM_CDAA = 0xB0, _MM_PERM_CDAB = 0xB1, _MM_PERM_CDAC = 0xB2, _MM_PERM_CDAD = 0xB3, _MM_PERM_CDBA = 0xB4, _MM_PERM_CDBB = 0xB5, _MM_PERM_CDBC = 0xB6, _MM_PERM_CDBD = 0xB7, _MM_PERM_CDCA = 0xB8, _MM_PERM_CDCB = 0xB9, _MM_PERM_CDCC = 0xBA, _MM_PERM_CDCD = 0xBB, _MM_PERM_CDDA = 0xBC, _MM_PERM_CDDB = 0xBD, _MM_PERM_CDDC = 0xBE, _MM_PERM_CDDD = 0xBF, _MM_PERM_DAAA = 0xC0, _MM_PERM_DAAB = 0xC1, _MM_PERM_DAAC = 0xC2, _MM_PERM_DAAD = 0xC3, _MM_PERM_DABA = 0xC4, _MM_PERM_DABB = 0xC5, _MM_PERM_DABC = 0xC6, _MM_PERM_DABD = 0xC7, _MM_PERM_DACA = 0xC8, _MM_PERM_DACB = 0xC9, _MM_PERM_DACC = 0xCA, _MM_PERM_DACD = 0xCB, _MM_PERM_DADA = 0xCC, _MM_PERM_DADB = 0xCD, _MM_PERM_DADC = 0xCE, _MM_PERM_DADD = 0xCF, _MM_PERM_DBAA = 0xD0, _MM_PERM_DBAB = 0xD1, _MM_PERM_DBAC = 0xD2, _MM_PERM_DBAD = 0xD3, _MM_PERM_DBBA = 0xD4, _MM_PERM_DBBB = 0xD5, _MM_PERM_DBBC = 0xD6, _MM_PERM_DBBD = 0xD7, _MM_PERM_DBCA = 0xD8, _MM_PERM_DBCB = 0xD9, _MM_PERM_DBCC = 0xDA, _MM_PERM_DBCD = 0xDB, _MM_PERM_DBDA = 0xDC, _MM_PERM_DBDB = 0xDD, _MM_PERM_DBDC = 0xDE, _MM_PERM_DBDD = 0xDF, _MM_PERM_DCAA = 0xE0, _MM_PERM_DCAB = 0xE1, _MM_PERM_DCAC = 0xE2, _MM_PERM_DCAD = 0xE3, _MM_PERM_DCBA = 0xE4, _MM_PERM_DCBB = 0xE5, _MM_PERM_DCBC = 0xE6, _MM_PERM_DCBD = 0xE7, _MM_PERM_DCCA = 0xE8, _MM_PERM_DCCB = 0xE9, _MM_PERM_DCCC = 0xEA, _MM_PERM_DCCD = 0xEB, _MM_PERM_DCDA = 0xEC, _MM_PERM_DCDB = 0xED, _MM_PERM_DCDC = 0xEE, _MM_PERM_DCDD = 0xEF, _MM_PERM_DDAA = 0xF0, _MM_PERM_DDAB = 0xF1, _MM_PERM_DDAC = 0xF2, _MM_PERM_DDAD = 0xF3, _MM_PERM_DDBA = 0xF4, _MM_PERM_DDBB = 0xF5, _MM_PERM_DDBC = 0xF6, _MM_PERM_DDBD = 0xF7, _MM_PERM_DDCA = 0xF8, _MM_PERM_DDCB = 0xF9, _MM_PERM_DDCC = 0xFA, _MM_PERM_DDCD = 0xFB, _MM_PERM_DDDA = 0xFC, _MM_PERM_DDDB = 0xFD, _MM_PERM_DDDC = 0xFE, _MM_PERM_DDDD = 0xFF } _MM_PERM_ENUM; typedef enum { _MM_FIXUP_NO_CHANGE, _MM_FIXUP_NEG_INF, _MM_FIXUP_NEG_ZERO, _MM_FIXUP_POS_ZERO, _MM_FIXUP_POS_INF, _MM_FIXUP_NAN, _MM_FIXUP_MAX_FLOAT, _MM_FIXUP_MIN_FLOAT } _MM_FIXUPRESULT_ENUM; #line 298 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" typedef enum { _MM_UPCONV_PS_NONE, _MM_UPCONV_PS_FLOAT16, _MM_UPCONV_PS_UINT8, _MM_UPCONV_PS_SINT8, _MM_UPCONV_PS_UINT16, _MM_UPCONV_PS_SINT16 } _MM_UPCONV_PS_ENUM; #line 343 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" typedef enum { _MM_UPCONV_EPI32_NONE, _MM_UPCONV_EPI32_UINT8, _MM_UPCONV_EPI32_SINT8, _MM_UPCONV_EPI32_UINT16, _MM_UPCONV_EPI32_SINT16 } _MM_UPCONV_EPI32_ENUM; #line 368 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 375 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" typedef enum { _MM_UPCONV_PD_NONE } _MM_UPCONV_PD_ENUM; #line 397 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" typedef enum { _MM_UPCONV_EPI64_NONE } _MM_UPCONV_EPI64_ENUM; #line 442 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" typedef enum { _MM_DOWNCONV_PS_NONE, _MM_DOWNCONV_PS_FLOAT16, _MM_DOWNCONV_PS_UINT8, _MM_DOWNCONV_PS_SINT8, _MM_DOWNCONV_PS_UINT16, _MM_DOWNCONV_PS_SINT16 } _MM_DOWNCONV_PS_ENUM; typedef enum { _MM_DOWNCONV_EPI32_NONE, _MM_DOWNCONV_EPI32_UINT8, _MM_DOWNCONV_EPI32_SINT8, _MM_DOWNCONV_EPI32_UINT16, _MM_DOWNCONV_EPI32_SINT16 } _MM_DOWNCONV_EPI32_ENUM; typedef enum { _MM_DOWNCONV_PD_NONE } _MM_DOWNCONV_PD_ENUM; typedef enum { _MM_DOWNCONV_EPI64_NONE } _MM_DOWNCONV_EPI64_ENUM; #line 515 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 549 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 573 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 683 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 708 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 780 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 823 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" typedef enum { _MM_CMPINT_EQ, _MM_CMPINT_LT, _MM_CMPINT_LE, _MM_CMPINT_UNUSED, _MM_CMPINT_NE, _MM_CMPINT_NLT, _MM_CMPINT_NLE } _MM_CMPINT_ENUM; #line 848 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 873 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 881 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 906 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 913 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 943 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 956 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 986 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 999 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1040 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1073 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1091 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1142 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1227 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1278 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1334 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1421 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1478 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1500 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" typedef enum { _MM_MANT_NORM_1_2, _MM_MANT_NORM_p5_2, _MM_MANT_NORM_p5_1, _MM_MANT_NORM_p75_1p5 } _MM_MANTISSA_NORM_ENUM; typedef enum { _MM_MANT_SIGN_src, _MM_MANT_SIGN_zero, _MM_MANT_SIGN_nan } _MM_MANTISSA_SIGN_ENUM; #line 1535 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1631 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1638 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1645 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1652 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1659 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1666 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1673 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1680 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1687 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1754 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1761 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1768 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1843 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1866 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1895 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1917 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1939 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1961 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 1983 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2005 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2046 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2128 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2146 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2192 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2231 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2259 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2287 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2316 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2349 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2408 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2425 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2439 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2456 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2472 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2511 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2551 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2890 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2960 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3042 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3061 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3091 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3202 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3219 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3236 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3261 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3269 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3294 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3366 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3373 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3381 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3388 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3396 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3407 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3626 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3633 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3641 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3648 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3656 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3663 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3671 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3678 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3687 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3694 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3702 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3709 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3717 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3724 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3732 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3739 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3761 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3768 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3776 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3783 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3935 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3942 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3950 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 3957 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4120 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4128 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4136 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4144 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4157 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4164 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4172 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4180 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4189 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4197 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4205 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4213 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4222 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4230 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4238 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4245 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4253 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4261 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4269 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4277 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4285 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4293 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4301 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4309 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4317 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4324 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4332 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4339 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4457 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4470 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4524 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4533 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4546 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4555 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4572 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4580 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4588 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4596 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4658 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4668 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4679 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4689 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4705 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4725 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4746 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4775 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4814 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4823 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4841 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4855 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4869 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4883 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4892 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4914 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4928 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4942 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 4956 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5007 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5017 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5029 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5039 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5050 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5060 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5072 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5082 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5093 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5103 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5126 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5137 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5147 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5170 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5196 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5327 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5337 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5347 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5357 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5364 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5371 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5381 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5391 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5404 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5411 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5418 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5453 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5469 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5500 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5514 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5528 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5546 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5572 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5629 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5636 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5643 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5650 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5657 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5664 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5671 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5678 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5685 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5692 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5699 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 5759 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6363 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6388 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6396 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6421 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6429 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6454 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6462 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6487 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6495 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6520 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6528 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6553 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6561 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6586 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6636 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6661 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6692 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6699 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6724 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6731 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6756 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6787 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6794 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6819 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6826 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6851 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6882 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6889 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6914 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6921 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6946 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6977 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 6984 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7009 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7016 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7041 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7444 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7452 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7467 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7475 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7520 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7528 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7543 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7551 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7568 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7576 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7593 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7601 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7649 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7657 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7672 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7680 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7695 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7703 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7718 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7726 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7743 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7751 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7766 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7774 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 7796 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 8755 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 8818 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 8835 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 8906 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 8924 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 10361 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 10401 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 10563 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 11159 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" #line 2523 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\immintrin.h" #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_IMMINTRIN_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: ieeefp.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "ieeefp.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "ieeefp.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: strings.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "strings.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "strings.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: inttypes.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\stdint.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\stdint.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" #pragma once typedef signed char int8_t; typedef short int16_t; typedef int int32_t; typedef long long int64_t; typedef unsigned char uint8_t; typedef unsigned short uint16_t; typedef unsigned int uint32_t; typedef unsigned long long uint64_t; typedef signed char int_least8_t; typedef short int_least16_t; typedef int int_least32_t; typedef long long int_least64_t; typedef unsigned char uint_least8_t; typedef unsigned short uint_least16_t; typedef unsigned int uint_least32_t; typedef unsigned long long uint_least64_t; typedef signed char int_fast8_t; typedef int int_fast16_t; typedef int int_fast32_t; typedef long long int_fast64_t; typedef unsigned char uint_fast8_t; typedef unsigned int uint_fast16_t; typedef unsigned int uint_fast32_t; typedef unsigned long long uint_fast64_t; typedef long long intmax_t; typedef unsigned long long uintmax_t; #line 60 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" #line 73 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" #line 86 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" #line 96 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" #line 23 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\stdint.h" #line 47 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\stdint.h" #line 23 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\stdint.h" #line 47 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\stdint.h" #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" __pragma(pack(push, 8)) typedef struct { intmax_t quot; intmax_t rem; } _Lldiv_t; typedef _Lldiv_t imaxdiv_t; intmax_t __cdecl imaxabs( intmax_t _Number ); imaxdiv_t __cdecl imaxdiv( intmax_t _Numerator, intmax_t _Denominator ); intmax_t __cdecl strtoimax( char const* _String, char** _EndPtr, int _Radix ); intmax_t __cdecl _strtoimax_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); uintmax_t __cdecl strtoumax( char const* _String, char** _EndPtr, int _Radix ); uintmax_t __cdecl _strtoumax_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); intmax_t __cdecl wcstoimax( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); intmax_t __cdecl _wcstoimax_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); uintmax_t __cdecl wcstoumax( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); uintmax_t __cdecl _wcstoumax_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); #line 128 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 147 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 166 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 185 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 204 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 223 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 249 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 268 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 287 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 306 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" #line 325 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\inttypes.h" __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_INTTYPES_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sched.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sched.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sched.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: cxxabi.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "cxxabi.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "cxxabi.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sys/systeminfo.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/systeminfo.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/systeminfo.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: dos.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\dos.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\dos.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\dos.h" struct _diskfree_t { unsigned total_clusters; unsigned avail_clusters; unsigned sectors_per_cluster; unsigned bytes_per_sector; }; unsigned __cdecl _getdiskfree( unsigned _Drive, struct _diskfree_t* _DiskFree ); __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_DOS_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: WindowsX.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winapifamily.h" #pragma warning(push) #pragma warning(disable:4001) #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winpackagefamily.h" #pragma warning(push) #pragma warning(disable:4001) #pragma once #line 57 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winpackagefamily.h" #line 84 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winpackagefamily.h" #pragma warning(pop) #line 27 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winapifamily.h" #line 143 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winapifamily.h" #line 154 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\winapifamily.h" #pragma warning(pop) #line 18 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #pragma region Desktop Family #line 42 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 93 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 153 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 171 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 423 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 654 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 980 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 1053 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 1096 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 1167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 1225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 1262 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 1295 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #line 1367 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\shared\\WindowsX.h" #pragma endregion #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_WINDOWSX_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sys/sysinfo.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/sysinfo.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/sysinfo.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: zmmintrin.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c E:\PROGRA~2\INTELS~1\COMPIL~2\windows\compiler\include\icc\zmmintrin.h(15): catastrophic error: #error directive: "Header should only be included from ." #error "Header should only be included from ." ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h" Possible ERROR while running preprocessor: exit code 1024 stdout: conftest.c E:\PROGRA~2\INTELS~1\COMPIL~2\windows\compiler\include\icc\zmmintrin.h(15): catastrophic error: #error directive: "Header should only be included from ." #error "Header should only be included from ." ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\icc\\zmmintrin.h"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sys/wait.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/wait.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/wait.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: stdlib.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" #pragma once __pragma(pack(push, 8)) #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __declspec(allocator) __declspec(restrict) void* __cdecl _calloc_base( size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl calloc( size_t _Count, size_t _Size ); int __cdecl _callnewh( size_t _Size ); __declspec(allocator) void* __cdecl _expand( void* _Block, size_t _Size ); void __cdecl _free_base( void* _Block ); void __cdecl free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _malloc_base( size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl malloc( size_t _Size ); size_t __cdecl _msize_base( void* _Block ); size_t __cdecl _msize( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _realloc_base( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl realloc( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc_base( void* _Block, size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc( void* _Block, size_t _Count, size_t _Size ); void __cdecl _aligned_free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_malloc( size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_malloc( size_t _Size, size_t _Alignment, size_t _Offset ); size_t __cdecl _aligned_msize( void* _Block, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_realloc( void* _Block, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_realloc( void* _Block, size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment ); #line 225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __pragma(pack(push, 8)) typedef int (__cdecl* _CoreCrtSecureSearchSortCompareFunction)(void*, void const*, void const*); typedef int (__cdecl* _CoreCrtNonSecureSearchSortCompareFunction)(void const*, void const*); void* __cdecl bsearch_s( void const* _Key, void const* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void __cdecl qsort_s( void* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl bsearch( void const* _Key, void const* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void __cdecl qsort( void* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lfind_s( void const* _Key, void const* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lsearch_s( void const* _Key, void* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); #line 185 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lfind" ". See online help for details.")) void* __cdecl lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lsearch" ". See online help for details.")) void* __cdecl lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma once __pragma(pack(push, 8)) errno_t __cdecl _itow_s( int _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _itow(int _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ltow_s( long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ltow(long _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ultow_s( unsigned long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ultow(unsigned long _Value, wchar_t *_Buffer, int _Radix); double __cdecl wcstod( wchar_t const* _String, wchar_t** _EndPtr ); double __cdecl _wcstod_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); long __cdecl wcstol( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long __cdecl _wcstol_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl wcstoll( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long long __cdecl _wcstoll_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl wcstoul( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long __cdecl _wcstoul_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl wcstoull( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long long __cdecl _wcstoull_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long double __cdecl wcstold( wchar_t const* _String, wchar_t** _EndPtr ); long double __cdecl _wcstold_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); float __cdecl wcstof( wchar_t const* _String, wchar_t** _EndPtr ); float __cdecl _wcstof_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); double __cdecl _wtof( wchar_t const* _String ); double __cdecl _wtof_l( wchar_t const* _String, _locale_t _Locale ); int __cdecl _wtoi( wchar_t const* _String ); int __cdecl _wtoi_l( wchar_t const* _String, _locale_t _Locale ); long __cdecl _wtol( wchar_t const* _String ); long __cdecl _wtol_l( wchar_t const* _String, _locale_t _Locale ); long long __cdecl _wtoll( wchar_t const* _String ); long long __cdecl _wtoll_l( wchar_t const* _String, _locale_t _Locale ); errno_t __cdecl _i64tow_s( __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _i64tow( __int64 _Value, wchar_t* _Buffer, int _Radix ); errno_t __cdecl _ui64tow_s( unsigned __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ui64tow( unsigned __int64 _Value, wchar_t* _Buffer, int _Radix ); __int64 __cdecl _wtoi64( wchar_t const* _String ); __int64 __cdecl _wtoi64_l( wchar_t const* _String, _locale_t _Locale ); __int64 __cdecl _wcstoi64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); __int64 __cdecl _wcstoi64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _wcstoui64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned __int64 __cdecl _wcstoui64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); __declspec(allocator) wchar_t* __cdecl _wfullpath( wchar_t* _Buffer, wchar_t const* _Path, size_t _BufferCount ); errno_t __cdecl _wmakepath_s( wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext ); #line 361 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wmakepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wmakepath( wchar_t *_Buffer, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext); #pragma warning(pop) void __cdecl _wperror( wchar_t const* _ErrorMessage ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsplitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsplitpath( wchar_t const* _FullPath, wchar_t* _Drive, wchar_t* _Dir, wchar_t* _Filename, wchar_t* _Ext ); errno_t __cdecl _wsplitpath_s( wchar_t const* _FullPath, wchar_t* _Drive, size_t _DriveCount, wchar_t* _Dir, size_t _DirCount, wchar_t* _Filename, size_t _FilenameCount, wchar_t* _Ext, size_t _ExtCount ); errno_t __cdecl _wdupenv_s( wchar_t** _Buffer, size_t* _BufferCount, wchar_t const* _VarName ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wdupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wgetenv( wchar_t const* _VarName ); errno_t __cdecl _wgetenv_s( size_t* _RequiredCount, wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _VarName ); #line 438 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" int __cdecl _wputenv( wchar_t const* _EnvString ); errno_t __cdecl _wputenv_s( wchar_t const* _Name, wchar_t const* _Value ); errno_t __cdecl _wsearchenv_s( wchar_t const* _Filename, wchar_t const* _VarName, wchar_t* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsearchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsearchenv(wchar_t const* _Filename, wchar_t const* _VarName, wchar_t *_ResultPath); int __cdecl _wsystem( wchar_t const* _Command ); __pragma(pack(pop)) #line 16 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #pragma once __pragma(pack(push, 8)) #line 29 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 43 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 71 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 79 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" __pragma(pack(pop)) #line 17 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __pragma(pack(push, 8)) void __cdecl _swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(noreturn) void __cdecl exit( int _Code); __declspec(noreturn) void __cdecl _exit( int _Code); __declspec(noreturn) void __cdecl _Exit( int _Code); __declspec(noreturn) void __cdecl quick_exit( int _Code); __declspec(noreturn) void __cdecl abort(void); unsigned int __cdecl _set_abort_behavior( unsigned int _Flags, unsigned int _Mask ); typedef int (__cdecl* _onexit_t)(void); #line 117 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 140 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl atexit(void (__cdecl*)(void)); _onexit_t __cdecl _onexit( _onexit_t _Func); int __cdecl at_quick_exit(void (__cdecl*)(void)); typedef void (__cdecl* _purecall_handler)(void); typedef void (__cdecl* _invalid_parameter_handler)( wchar_t const*, wchar_t const*, wchar_t const*, unsigned int, uintptr_t ); _purecall_handler __cdecl _set_purecall_handler( _purecall_handler _Handler ); _purecall_handler __cdecl _get_purecall_handler(void); _invalid_parameter_handler __cdecl _set_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_invalid_parameter_handler(void); _invalid_parameter_handler __cdecl _set_thread_local_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_thread_local_invalid_parameter_handler(void); #line 199 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl _set_error_mode( int _Mode); int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); unsigned long* __cdecl __doserrno(void); errno_t __cdecl _set_doserrno( unsigned long _Value); errno_t __cdecl _get_doserrno( unsigned long * _Value); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __sys_errlist(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int * __cdecl __sys_nerr(void); void __cdecl perror( char const* _ErrMsg); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_pgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __p__pgmptr (void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_wpgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t** __cdecl __p__wpgmptr(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_fmode" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int* __cdecl __p__fmode (void); #line 253 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" errno_t __cdecl _get_pgmptr ( char** _Value); errno_t __cdecl _get_wpgmptr( wchar_t** _Value); errno_t __cdecl _set_fmode ( int _Mode ); errno_t __cdecl _get_fmode ( int* _PMode); typedef struct _div_t { int quot; int rem; } div_t; typedef struct _ldiv_t { long quot; long rem; } ldiv_t; typedef struct _lldiv_t { long long quot; long long rem; } lldiv_t; int __cdecl abs ( int _Number); long __cdecl labs ( long _Number); long long __cdecl llabs ( long long _Number); __int64 __cdecl _abs64( __int64 _Number); unsigned short __cdecl _byteswap_ushort( unsigned short _Number); unsigned long __cdecl _byteswap_ulong ( unsigned long _Number); unsigned __int64 __cdecl _byteswap_uint64( unsigned __int64 _Number); div_t __cdecl div ( int _Numerator, int _Denominator); ldiv_t __cdecl ldiv ( long _Numerator, long _Denominator); lldiv_t __cdecl lldiv( long long _Numerator, long long _Denominator); #pragma warning (push) #pragma warning (disable:6540) unsigned int __cdecl _rotl( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotl( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotl64( unsigned __int64 _Value, int _Shift ); unsigned int __cdecl _rotr( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotr( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotr64( unsigned __int64 _Value, int _Shift ); #pragma warning (pop) void __cdecl srand( unsigned int _Seed); int __cdecl rand(void); #line 380 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma pack(push, 4) typedef struct { unsigned char ld[10]; } _LDOUBLE; #pragma pack(pop) #line 410 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" typedef struct { double x; } _CRT_DOUBLE; typedef struct { float f; } _CRT_FLOAT; typedef struct { long double x; } _LONGDOUBLE; #pragma pack(push, 4) typedef struct { unsigned char ld12[12]; } _LDBL12; #pragma pack(pop) double __cdecl atof ( char const* _String); int __cdecl atoi ( char const* _String); long __cdecl atol ( char const* _String); long long __cdecl atoll ( char const* _String); __int64 __cdecl _atoi64( char const* _String); double __cdecl _atof_l ( char const* _String, _locale_t _Locale); int __cdecl _atoi_l ( char const* _String, _locale_t _Locale); long __cdecl _atol_l ( char const* _String, _locale_t _Locale); long long __cdecl _atoll_l ( char const* _String, _locale_t _Locale); __int64 __cdecl _atoi64_l( char const* _String, _locale_t _Locale); int __cdecl _atoflt ( _CRT_FLOAT* _Result, char const* _String); int __cdecl _atodbl ( _CRT_DOUBLE* _Result, char* _String); int __cdecl _atoldbl( _LDOUBLE* _Result, char* _String); int __cdecl _atoflt_l( _CRT_FLOAT* _Result, char const* _String, _locale_t _Locale ); int __cdecl _atodbl_l( _CRT_DOUBLE* _Result, char* _String, _locale_t _Locale ); int __cdecl _atoldbl_l( _LDOUBLE* _Result, char* _String, _locale_t _Locale ); float __cdecl strtof( char const* _String, char** _EndPtr ); float __cdecl _strtof_l( char const* _String, char** _EndPtr, _locale_t _Locale ); double __cdecl strtod( char const* _String, char** _EndPtr ); double __cdecl _strtod_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long double __cdecl strtold( char const* _String, char** _EndPtr ); long double __cdecl _strtold_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long __cdecl strtol( char const* _String, char** _EndPtr, int _Radix ); long __cdecl _strtol_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl strtoll( char const* _String, char** _EndPtr, int _Radix ); long long __cdecl _strtoll_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl strtoul( char const* _String, char** _EndPtr, int _Radix ); unsigned long __cdecl _strtoul_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl strtoull( char const* _String, char** _EndPtr, int _Radix ); unsigned long long __cdecl _strtoull_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); __int64 __cdecl _strtoi64( char const* _String, char** _EndPtr, int _Radix ); __int64 __cdecl _strtoi64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _strtoui64( char const* _String, char** _EndPtr, int _Radix ); unsigned __int64 __cdecl _strtoui64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); errno_t __cdecl _itoa_s( int _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _itoa(int _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _ltoa_s( long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ltoa(long _Value, char *_Buffer, int _Radix); errno_t __cdecl _ultoa_s( unsigned long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ultoa(unsigned long _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _i64toa_s( __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _i64toa( __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ui64toa_s( unsigned __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ui64toa( unsigned __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ecvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _fcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _gcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _gcvt( double _Value, int _DigitCount, char* _Buffer ); #line 838 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl ___mb_cur_max_func(void); int __cdecl ___mb_cur_max_l_func(_locale_t _Locale); int __cdecl mblen( char const* _Ch, size_t _MaxCount ); int __cdecl _mblen_l( char const* _Ch, size_t _MaxCount, _locale_t _Locale ); size_t __cdecl _mbstrlen( char const* _String ); size_t __cdecl _mbstrlen_l( char const* _String, _locale_t _Locale ); size_t __cdecl _mbstrnlen( char const* _String, size_t _MaxCount ); size_t __cdecl _mbstrnlen_l( char const* _String, size_t _MaxCount, _locale_t _Locale ); int __cdecl mbtowc( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes ); int __cdecl _mbtowc_l( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes, _locale_t _Locale ); errno_t __cdecl mbstowcs_s( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "mbstowcs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl mbstowcs( wchar_t *_Dest, char const* _Source, size_t _MaxCount); errno_t __cdecl _mbstowcs_s_l( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_mbstowcs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _mbstowcs_l( wchar_t *_Dest, char const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wctomb_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl wctomb( char* _MbCh, wchar_t _WCh ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctomb_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _wctomb_l( char* _MbCh, wchar_t _WCh, _locale_t _Locale ); errno_t __cdecl wctomb_s( int* _SizeConverted, char* _MbCh, rsize_t _SizeInBytes, wchar_t _WCh ); errno_t __cdecl _wctomb_s_l( int* _SizeConverted, char* _MbCh, size_t _SizeInBytes, wchar_t _WCh, _locale_t _Locale); errno_t __cdecl wcstombs_s( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstombs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl wcstombs( char *_Dest, wchar_t const* _Source, size_t _MaxCount); errno_t __cdecl _wcstombs_s_l( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcstombs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _wcstombs_l( char *_Dest, wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(allocator) char* __cdecl _fullpath( char* _Buffer, char const* _Path, size_t _BufferCount ); errno_t __cdecl _makepath_s( char* _Buffer, size_t _BufferCount, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_makepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _makepath( char *_Buffer, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext); #pragma warning(pop) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_splitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _splitpath( char const* _FullPath, char* _Drive, char* _Dir, char* _Filename, char* _Ext ); errno_t __cdecl _splitpath_s( char const* _FullPath, char* _Drive, size_t _DriveCount, char* _Dir, size_t _DirCount, char* _Filename, size_t _FilenameCount, char* _Ext, size_t _ExtCount ); errno_t __cdecl getenv_s( size_t* _RequiredCount, char* _Buffer, rsize_t _BufferCount, char const* _VarName ); int* __cdecl __p___argc (void); char*** __cdecl __p___argv (void); wchar_t*** __cdecl __p___wargv(void); #line 1164 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" char*** __cdecl __p__environ (void); wchar_t*** __cdecl __p__wenviron(void); #line 1181 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "_dupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl getenv( char const* _VarName ); errno_t __cdecl _dupenv_s( char** _Buffer, size_t* _BufferCount, char const* _VarName ); int __cdecl system( char const* _Command ); #pragma warning (push) #pragma warning (disable:6540) int __cdecl _putenv( char const* _EnvString ); errno_t __cdecl _putenv_s( char const* _Name, char const* _Value ); #pragma warning (pop) errno_t __cdecl _searchenv_s( char const* _Filename, char const* _VarName, char* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_searchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _searchenv(char const* _Filename, char const* _VarName, char *_Buffer); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "SetErrorMode" " " "instead. See online help for details.")) void __cdecl _seterrormode( int _Mode ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Beep" " " "instead. See online help for details.")) void __cdecl _beep( unsigned _Frequency, unsigned _Duration ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Sleep" " " "instead. See online help for details.")) void __cdecl _sleep( unsigned long _Duration ); #pragma warning(push) #pragma warning(disable: 4141) __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ecvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_fcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_gcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl gcvt( double _Value, int _DigitCount, char* _DstBuf ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_itoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl itoa( int _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ltoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ltoa( long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_swab" ". See online help for details.")) void __cdecl swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ultoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ultoa( unsigned long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_putenv" ". See online help for details.")) int __cdecl putenv( char const* _EnvString ); #pragma warning(pop) _onexit_t __cdecl onexit( _onexit_t _Func); __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_STDLIB_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: pthread.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "pthread.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "pthread.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: setjmp.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\setjmp.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 12 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\setjmp.h" #line 20 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\setjmp.h" __pragma(pack(push, 8)) #line 47 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\setjmp.h" typedef struct __declspec(align(16)) _SETJMP_FLOAT128 { unsigned __int64 Part[2]; } SETJMP_FLOAT128; typedef SETJMP_FLOAT128 _JBTYPE; typedef struct _JUMP_BUFFER { unsigned __int64 Frame; unsigned __int64 Rbx; unsigned __int64 Rsp; unsigned __int64 Rbp; unsigned __int64 Rsi; unsigned __int64 Rdi; unsigned __int64 R12; unsigned __int64 R13; unsigned __int64 R14; unsigned __int64 R15; unsigned __int64 Rip; unsigned long MxCsr; unsigned short FpCsr; unsigned short Spare; SETJMP_FLOAT128 Xmm6; SETJMP_FLOAT128 Xmm7; SETJMP_FLOAT128 Xmm8; SETJMP_FLOAT128 Xmm9; SETJMP_FLOAT128 Xmm10; SETJMP_FLOAT128 Xmm11; SETJMP_FLOAT128 Xmm12; SETJMP_FLOAT128 Xmm13; SETJMP_FLOAT128 Xmm14; SETJMP_FLOAT128 Xmm15; } _JUMP_BUFFER; #line 139 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\setjmp.h" typedef _JBTYPE jmp_buf[16]; int __cdecl _setjmp( jmp_buf _Buf ); #line 167 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\setjmp.h" __declspec(noreturn) void __cdecl longjmp( jmp_buf _Buf, int _Value ); __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_SETJMP_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sys/utsname.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/utsname.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/utsname.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: machine/endian.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "machine/endian.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "machine/endian.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: limits.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 12 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" __pragma(pack(push, 8)) #line 29 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 43 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 71 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 79 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_LIMITS_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: fcntl.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\fcntl.h" #pragma once #line 41 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\fcntl.h" #line 60 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\fcntl.h" #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_FCNTL_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: string.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" #pragma once __pragma(pack(push, 8)) int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); unsigned long* __cdecl __doserrno(void); errno_t __cdecl _set_doserrno( unsigned long _Value); errno_t __cdecl _get_doserrno( unsigned long * _Value); #line 70 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" #line 79 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" #line 127 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\errno.h" __pragma(pack(pop)) #line 12 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime_string.h" #pragma once __pragma(pack(push, 8)) void * __cdecl memchr( void const* _Buf, int _Val, size_t _MaxCount ); int __cdecl memcmp( void const* _Buf1, void const* _Buf2, size_t _Size ); void* __cdecl memcpy( void* _Dst, void const* _Src, size_t _Size ); void* __cdecl memmove( void* _Dst, void const* _Src, size_t _Size ); void* __cdecl memset( void* _Dst, int _Val, size_t _Size ); char * __cdecl strchr( char const* _Str, int _Val ); char * __cdecl strrchr( char const* _Str, int _Ch ); char * __cdecl strstr( char const* _Str, char const* _SubStr ); wchar_t * __cdecl wcschr( wchar_t const* _Str, wchar_t _Ch ); wchar_t * __cdecl wcsrchr( wchar_t const* _Str, wchar_t _Ch ); wchar_t * __cdecl wcsstr( wchar_t const* _Str, wchar_t const* _SubStr ); __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memcpy_s.h" static __inline errno_t __cdecl memcpy_s( void* const _Destination, rsize_t const _DestinationSize, void const* const _Source, rsize_t const _SourceSize ) { if (_SourceSize == 0) { return 0; } { int _Expr_val=!!(_Destination != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; if (_Source == ((void *)0) || _DestinationSize < _SourceSize) { memset(_Destination, 0, _DestinationSize); { int _Expr_val=!!(_Source != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; { int _Expr_val=!!(_DestinationSize >= _SourceSize); if (!(_Expr_val)) { (*_errno()) = 34; _invalid_parameter_noinfo(); return 34; } }; return 22; } memcpy(_Destination, _Source, _SourceSize); return 0; } static __inline errno_t __cdecl memmove_s( void* const _Destination, rsize_t const _DestinationSize, void const* const _Source, rsize_t const _SourceSize ) { if (_SourceSize == 0) { return 0; } { int _Expr_val=!!(_Destination != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; { int _Expr_val=!!(_Source != ((void *)0)); if (!(_Expr_val)) { (*_errno()) = 22; _invalid_parameter_noinfo(); return 22; } }; { int _Expr_val=!!(_DestinationSize >= _SourceSize); if (!(_Expr_val)) { (*_errno()) = 34; _invalid_parameter_noinfo(); return 34; } }; memmove(_Destination, _Source, _SourceSize); return 0; } __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" __pragma(pack(push, 8)) int __cdecl _memicmp( void const* _Buf1, void const* _Buf2, size_t _Size ); int __cdecl _memicmp_l( void const* _Buf1, void const* _Buf2, size_t _Size, _locale_t _Locale ); #line 56 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" #line 71 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_memccpy" ". See online help for details.")) void* __cdecl memccpy( void* _Dst, void const* _Src, int _Val, size_t _Size ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_memicmp" ". See online help for details.")) int __cdecl memicmp( void const* _Buf1, void const* _Buf2, size_t _Size ); #line 111 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_memory.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" #pragma once __pragma(pack(push, 8)) errno_t __cdecl wcscat_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source ); errno_t __cdecl wcscpy_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source ); errno_t __cdecl wcsncat_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source, rsize_t _MaxCount ); errno_t __cdecl wcsncpy_s( wchar_t* _Destination, rsize_t _SizeInWords, wchar_t const* _Source, rsize_t _MaxCount ); wchar_t* __cdecl wcstok_s( wchar_t* _String, wchar_t const* _Delimiter, wchar_t** _Context ); __declspec(allocator) wchar_t* __cdecl _wcsdup( wchar_t const* _String ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcscat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcscat( wchar_t *_Destination, wchar_t const* _Source); #pragma warning(pop) int __cdecl wcscmp( wchar_t const* _String1, wchar_t const* _String2 ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcscpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcscpy( wchar_t *_Destination, wchar_t const* _Source); #pragma warning(pop) size_t __cdecl wcscspn( wchar_t const* _String, wchar_t const* _Control ); size_t __cdecl wcslen( wchar_t const* _String ); size_t __cdecl wcsnlen( wchar_t const* _Source, size_t _MaxCount ); static __inline size_t __cdecl wcsnlen_s( wchar_t const* _Source, size_t _MaxCount ) { return (_Source == 0) ? 0 : wcsnlen(_Source, _MaxCount); } __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcsncat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcsncat( wchar_t *_Destination, wchar_t const* _Source, size_t _Count); int __cdecl wcsncmp( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcsncpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcsncpy( wchar_t *_Destination, wchar_t const* _Source, size_t _Count); wchar_t * __cdecl wcspbrk( wchar_t const* _String, wchar_t const* _Control ); size_t __cdecl wcsspn( wchar_t const* _String, wchar_t const* _Control ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstok_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl wcstok( wchar_t* _String, wchar_t const* _Delimiter, wchar_t** _Context ); #line 242 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" #pragma warning(push) #pragma warning(disable: 4141 4996) #pragma warning(disable: 28719 28726 28727) __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstok_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) static __inline wchar_t* __cdecl _wcstok( wchar_t* const _String, wchar_t const* const _Delimiter ) { return wcstok(_String, _Delimiter, 0); } #line 269 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" #pragma warning(pop) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcserror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcserror( int _ErrorNumber ); errno_t __cdecl _wcserror_s( wchar_t* _Buffer, size_t _SizeInWords, int _ErrorNumber ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "__wcserror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl __wcserror( wchar_t const* _String ); errno_t __cdecl __wcserror_s( wchar_t* _Buffer, size_t _SizeInWords, wchar_t const* _ErrorMessage ); int __cdecl _wcsicmp( wchar_t const* _String1, wchar_t const* _String2 ); int __cdecl _wcsicmp_l( wchar_t const* _String1, wchar_t const* _String2, _locale_t _Locale ); int __cdecl _wcsnicmp( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); int __cdecl _wcsnicmp_l( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount, _locale_t _Locale ); errno_t __cdecl _wcsnset_s( wchar_t* _Destination, size_t _SizeInWords, wchar_t _Value, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsnset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsnset( wchar_t *_String, wchar_t _Value, size_t _MaxCount); wchar_t* __cdecl _wcsrev( wchar_t* _String ); errno_t __cdecl _wcsset_s( wchar_t* _Destination, size_t _SizeInWords, wchar_t _Value ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsset( wchar_t *_String, wchar_t _Value); errno_t __cdecl _wcslwr_s( wchar_t* _String, size_t _SizeInWords ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcslwr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcslwr( wchar_t *_String); errno_t __cdecl _wcslwr_s_l( wchar_t* _String, size_t _SizeInWords, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcslwr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcslwr_l( wchar_t *_String, _locale_t _Locale); errno_t __cdecl _wcsupr_s( wchar_t* _String, size_t _Size ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsupr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsupr( wchar_t *_String); errno_t __cdecl _wcsupr_s_l( wchar_t* _String, size_t _Size, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcsupr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wcsupr_l( wchar_t *_String, _locale_t _Locale); size_t __cdecl wcsxfrm( wchar_t* _Destination, wchar_t const* _Source, size_t _MaxCount ); size_t __cdecl _wcsxfrm_l( wchar_t* _Destination, wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale ); int __cdecl wcscoll( wchar_t const* _String1, wchar_t const* _String2 ); int __cdecl _wcscoll_l( wchar_t const* _String1, wchar_t const* _String2, _locale_t _Locale ); int __cdecl _wcsicoll( wchar_t const* _String1, wchar_t const* _String2 ); int __cdecl _wcsicoll_l( wchar_t const* _String1, wchar_t const* _String2, _locale_t _Locale ); int __cdecl _wcsncoll( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); int __cdecl _wcsncoll_l( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount, _locale_t _Locale ); int __cdecl _wcsnicoll( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); int __cdecl _wcsnicoll_l( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount, _locale_t _Locale ); #line 565 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstring.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsdup" ". See online help for details.")) wchar_t* __cdecl wcsdup( wchar_t const* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsicmp" ". See online help for details.")) int __cdecl wcsicmp( wchar_t const* _String1, wchar_t const* _String2 ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsnicmp" ". See online help for details.")) int __cdecl wcsnicmp( wchar_t const* _String1, wchar_t const* _String2, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsnset" ". See online help for details.")) wchar_t* __cdecl wcsnset( wchar_t* _String, wchar_t _Value, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsrev" ". See online help for details.")) wchar_t* __cdecl wcsrev( wchar_t* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsset" ". See online help for details.")) wchar_t* __cdecl wcsset( wchar_t* _String, wchar_t _Value ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcslwr" ". See online help for details.")) wchar_t* __cdecl wcslwr( wchar_t* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsupr" ". See online help for details.")) wchar_t* __cdecl wcsupr( wchar_t* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_wcsicoll" ". See online help for details.")) int __cdecl wcsicoll( wchar_t const* _String1, wchar_t const* _String2 ); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" __pragma(pack(push, 8)) errno_t __cdecl strcpy_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source ); errno_t __cdecl strcat_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source ); errno_t __cdecl strerror_s( char* _Buffer, size_t _SizeInBytes, int _ErrorNumber); errno_t __cdecl strncat_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source, rsize_t _MaxCount ); errno_t __cdecl strncpy_s( char* _Destination, rsize_t _SizeInBytes, char const* _Source, rsize_t _MaxCount ); char* __cdecl strtok_s( char* _String, char const* _Delimiter, char** _Context ); void* __cdecl _memccpy( void* _Dst, void const* _Src, int _Val, size_t _MaxCount ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "strcat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strcat( char *_Destination, char const* _Source); #pragma warning(pop) int __cdecl strcmp( char const* _Str1, char const* _Str2 ); int __cdecl _strcmpi( char const* _String1, char const* _String2 ); int __cdecl strcoll( char const* _String1, char const* _String2 ); int __cdecl _strcoll_l( char const* _String1, char const* _String2, _locale_t _Locale ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "strcpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strcpy( char *_Destination, char const* _Source); #pragma warning(pop) size_t __cdecl strcspn( char const* _Str, char const* _Control ); __declspec(allocator) char* __cdecl _strdup( char const* _Source ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strerror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strerror( char const* _ErrorMessage ); errno_t __cdecl _strerror_s( char* _Buffer, size_t _SizeInBytes, char const* _ErrorMessage ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strerror( int _ErrorMessage ); int __cdecl _stricmp( char const* _String1, char const* _String2 ); int __cdecl _stricoll( char const* _String1, char const* _String2 ); int __cdecl _stricoll_l( char const* _String1, char const* _String2, _locale_t _Locale ); int __cdecl _stricmp_l( char const* _String1, char const* _String2, _locale_t _Locale ); size_t __cdecl strlen( char const* _Str ); errno_t __cdecl _strlwr_s( char* _String, size_t _Size ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strlwr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strlwr( char *_String); errno_t __cdecl _strlwr_s_l( char* _String, size_t _Size, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strlwr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strlwr_l( char *_String, _locale_t _Locale); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strncat_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strncat( char *_Destination, char const* _Source, size_t _Count); int __cdecl strncmp( char const* _Str1, char const* _Str2, size_t _MaxCount ); int __cdecl _strnicmp( char const* _String1, char const* _String2, size_t _MaxCount ); int __cdecl _strnicmp_l( char const* _String1, char const* _String2, size_t _MaxCount, _locale_t _Locale ); int __cdecl _strnicoll( char const* _String1, char const* _String2, size_t _MaxCount ); int __cdecl _strnicoll_l( char const* _String1, char const* _String2, size_t _MaxCount, _locale_t _Locale ); int __cdecl _strncoll( char const* _String1, char const* _String2, size_t _MaxCount ); int __cdecl _strncoll_l( char const* _String1, char const* _String2, size_t _MaxCount, _locale_t _Locale ); size_t __cdecl __strncnt( char const* _String, size_t _Count ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strncpy_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strncpy( char *_Destination, char const* _Source, size_t _Count); size_t __cdecl strnlen( char const* _String, size_t _MaxCount ); static __inline size_t __cdecl strnlen_s( char const* _String, size_t _MaxCount ) { return _String == 0 ? 0 : strnlen(_String, _MaxCount); } errno_t __cdecl _strnset_s( char* _String, size_t _SizeInBytes, int _Value, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strnset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strnset( char *_Destination, int _Value, size_t _Count); char * __cdecl strpbrk( char const* _Str, char const* _Control ); char* __cdecl _strrev( char* _Str ); errno_t __cdecl _strset_s( char* _Destination, size_t _DestinationSize, int _Value ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strset_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strset( char *_Destination, int _Value); size_t __cdecl strspn( char const* _Str, char const* _Control ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strtok_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl strtok( char* _String, char const* _Delimiter ); errno_t __cdecl _strupr_s( char* _String, size_t _Size ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strupr_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strupr( char *_String); errno_t __cdecl _strupr_s_l( char* _String, size_t _Size, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_strupr_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _strupr_l( char *_String, _locale_t _Locale); size_t __cdecl strxfrm( char* _Destination, char const* _Source, size_t _MaxCount ); size_t __cdecl _strxfrm_l( char* _Destination, char const* _Source, size_t _MaxCount, _locale_t _Locale ); #line 528 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\string.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strdup" ". See online help for details.")) char* __cdecl strdup( char const* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strcmpi" ". See online help for details.")) int __cdecl strcmpi( char const* _String1, char const* _String2 ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_stricmp" ". See online help for details.")) int __cdecl stricmp( char const* _String1, char const* _String2 ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strlwr" ". See online help for details.")) char* __cdecl strlwr( char* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strnicmp" ". See online help for details.")) int __cdecl strnicmp( char const* _String1, char const* _String2, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strnset" ". See online help for details.")) char* __cdecl strnset( char* _String, int _Value, size_t _MaxCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strrev" ". See online help for details.")) char* __cdecl strrev( char* _String ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strset" ". See online help for details.")) char* __cdecl strset( char* _String, int _Value); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_strupr" ". See online help for details.")) char* __cdecl strupr( char* _String ); __pragma(pack(pop)) #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_STRING_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sys/times.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/times.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/times.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: io.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\io.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_io.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_share.h" #pragma once #line 12 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_io.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wio.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 12 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wio.h" __pragma(pack(push, 8)) #pragma warning(push) #pragma warning(disable:4820) #line 33 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wio.h" typedef unsigned long _fsize_t; struct _wfinddata32_t { unsigned attrib; __time32_t time_create; __time32_t time_access; __time32_t time_write; _fsize_t size; wchar_t name[260]; }; struct _wfinddata32i64_t { unsigned attrib; __time32_t time_create; __time32_t time_access; __time32_t time_write; __int64 size; wchar_t name[260]; }; struct _wfinddata64i32_t { unsigned attrib; __time64_t time_create; __time64_t time_access; __time64_t time_write; _fsize_t size; wchar_t name[260]; }; struct _wfinddata64_t { unsigned attrib; __time64_t time_create; __time64_t time_access; __time64_t time_write; __int64 size; wchar_t name[260]; }; #line 94 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wio.h" int __cdecl _waccess( wchar_t const* _FileName, int _AccessMode ); errno_t __cdecl _waccess_s( wchar_t const* _FileName, int _AccessMode ); int __cdecl _wchmod( wchar_t const* _FileName, int _Mode ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsopen_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _wcreat( wchar_t const* _FileName, int _PermissionMode ); intptr_t __cdecl _wfindfirst32( wchar_t const* _FileName, struct _wfinddata32_t* _FindData ); int __cdecl _wfindnext32( intptr_t _FindHandle, struct _wfinddata32_t* _FindData ); int __cdecl _wunlink( wchar_t const* _FileName ); int __cdecl _wrename( wchar_t const* _OldFileName, wchar_t const* _NewFileName ); errno_t __cdecl _wmktemp_s( wchar_t* _TemplateName, size_t _SizeInWords ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wmktemp_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wmktemp( wchar_t *_TemplateName); intptr_t __cdecl _wfindfirst32i64( wchar_t const* _FileName, struct _wfinddata32i64_t* _FindData ); intptr_t __cdecl _wfindfirst64i32( wchar_t const* _FileName, struct _wfinddata64i32_t* _FindData ); intptr_t __cdecl _wfindfirst64( wchar_t const* _FileName, struct _wfinddata64_t* _FindData ); int __cdecl _wfindnext32i64( intptr_t _FindHandle, struct _wfinddata32i64_t* _FindData ); int __cdecl _wfindnext64i32( intptr_t _FindHandle, struct _wfinddata64i32_t* _FindData ); int __cdecl _wfindnext64( intptr_t _FindHandle, struct _wfinddata64_t* _FindData ); errno_t __cdecl _wsopen_s( int* _FileHandle, wchar_t const* _FileName, int _OpenFlag, int _ShareFlag, int _PermissionFlag ); errno_t __cdecl _wsopen_dispatch( wchar_t const* _FileName, int _OFlag, int _ShFlag, int _PMode, int* _PFileHandle, int _BSecure ); #line 253 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wio.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsopen_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _wopen( wchar_t const* _FileName, int _OpenFlag, ...); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsopen_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _wsopen( wchar_t const* _FileName, int _OpenFlag, int _ShareFlag, ...); #pragma warning(pop) __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_io.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_io.h" struct _finddata32_t { unsigned attrib; __time32_t time_create; __time32_t time_access; __time32_t time_write; _fsize_t size; char name[260]; }; struct _finddata32i64_t { unsigned attrib; __time32_t time_create; __time32_t time_access; __time32_t time_write; __int64 size; char name[260]; }; struct _finddata64i32_t { unsigned attrib; __time64_t time_create; __time64_t time_access; __time64_t time_write; _fsize_t size; char name[260]; }; struct __finddata64_t { unsigned attrib; __time64_t time_create; __time64_t time_access; __time64_t time_write; __int64 size; char name[260]; }; #line 85 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_io.h" #line 104 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_io.h" int __cdecl _access( char const* _FileName, int _AccessMode ); errno_t __cdecl _access_s( char const* _FileName, int _AccessMode ); int __cdecl _chmod( char const* _FileName, int _Mode ); int __cdecl _chsize( int _FileHandle, long _Size ); errno_t __cdecl _chsize_s( int _FileHandle, __int64 _Size ); int __cdecl _close( int _FileHandle ); int __cdecl _commit( int _FileHandle ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_sopen_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _creat( char const* _FileName, int _PermissionMode ); int __cdecl _dup( int _FileHandle ); int __cdecl _dup2( int _FileHandleSrc, int _FileHandleDst ); int __cdecl _eof( int _FileHandle ); long __cdecl _filelength( int _FileHandle ); intptr_t __cdecl _findfirst32( char const* _FileName, struct _finddata32_t* _FindData ); int __cdecl _findnext32( intptr_t _FindHandle, struct _finddata32_t* _FindData ); int __cdecl _findclose( intptr_t _FindHandle ); intptr_t __cdecl _get_osfhandle( int _FileHandle ); int __cdecl _isatty( int _FileHandle ); int __cdecl _locking( int _FileHandle, int _LockMode, long _NumOfBytes ); long __cdecl _lseek( int _FileHandle, long _Offset, int _Origin ); errno_t __cdecl _mktemp_s( char* _TemplateName, size_t _Size ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_mktemp_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char * __cdecl _mktemp( char *_TemplateName); int __cdecl _open_osfhandle( intptr_t _OSFileHandle, int _Flags ); int __cdecl _pipe( int* _PtHandles, unsigned int _PipeSize, int _TextMode ); int __cdecl _read( int _FileHandle, void* _DstBuf, unsigned int _MaxCharCount ); int __cdecl remove( char const* _FileName ); int __cdecl rename( char const* _OldFilename, char const* _NewFilename ); int __cdecl _unlink( char const* _FileName ); int __cdecl _setmode( int _FileHandle, int _Mode ); long __cdecl _tell( int _FileHandle ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_umask_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _umask( int _Mode ); errno_t __cdecl _umask_s( int _NewMode, int* _OldMode ); int __cdecl _write( int _FileHandle, void const* _Buf, unsigned int _MaxCharCount ); __int64 __cdecl _filelengthi64( int _FileHandle ); intptr_t __cdecl _findfirst32i64( char const* _FileName, struct _finddata32i64_t* _FindData ); intptr_t __cdecl _findfirst64i32( char const* _FileName, struct _finddata64i32_t* _FindData ); intptr_t __cdecl _findfirst64( char const* _FileName, struct __finddata64_t* _FindData ); int __cdecl _findnext32i64( intptr_t _FindHandle, struct _finddata32i64_t* _FindData ); int __cdecl _findnext64i32( intptr_t _FindHandle, struct _finddata64i32_t* _FindData ); int __cdecl _findnext64( intptr_t _FindHandle, struct __finddata64_t* _FindData ); __int64 __cdecl _lseeki64( int _FileHandle, __int64 _Offset, int _Origin ); __int64 __cdecl _telli64( int _FileHandle ); errno_t __cdecl _sopen_s( int* _FileHandle, char const* _FileName, int _OpenFlag, int _ShareFlag, int _PermissionMode ); errno_t __cdecl _sopen_s_nolock( int* _FileHandle, char const* _FileName, int _OpenFlag, int _ShareFlag, int _PermissionMode ); errno_t __cdecl _sopen_dispatch( char const* _FileName, int _OFlag, int _ShFlag, int _PMode, int* _PFileHandle, int _BSecure ); #line 417 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_io.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "_sopen_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _open( char const* _FileName, int _OpenFlag, ...); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_sopen_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _sopen( char const* _FileName, int _OpenFlag, int _ShareFlag, ...); #pragma warning(push) #pragma warning(disable: 4141) __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_access" ". See online help for details.")) int __cdecl access( char const* _FileName, int _AccessMode ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_chmod" ". See online help for details.")) int __cdecl chmod( char const* _FileName, int _AccessMode ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_chsize" ". See online help for details.")) int __cdecl chsize( int _FileHandle, long _Size ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_close" ". See online help for details.")) int __cdecl close( int _FileHandle ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_creat" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_sopen_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl creat( char const* _FileName, int _PermissionMode ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_dup" ". See online help for details.")) int __cdecl dup( int _FileHandle ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_dup2" ". See online help for details.")) int __cdecl dup2( int _FileHandleSrc, int _FileHandleDst ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_eof" ". See online help for details.")) int __cdecl eof( int _FileHandle ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_filelength" ". See online help for details.")) long __cdecl filelength( int _FileHandle ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_isatty" ". See online help for details.")) int __cdecl isatty( int _FileHandle ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_locking" ". See online help for details.")) int __cdecl locking( int _FileHandle, int _LockMode, long _NumOfBytes ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lseek" ". See online help for details.")) long __cdecl lseek( int _FileHandle, long _Offset, int _Origin ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_mktemp" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_mktemp_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char * __cdecl mktemp( char* _TemplateName ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_open" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_sopen_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl open( char const* _FileName, int _OpenFlag, ...); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_read" ". See online help for details.")) int __cdecl read( int _FileHandle, void* _DstBuf, unsigned int _MaxCharCount ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_setmode" ". See online help for details.")) int __cdecl setmode( int _FileHandle, int _Mode ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_sopen" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_sopen_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl sopen( char const* _FileName, int _OpenFlag, int _ShareFlag, ...); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_tell" ". See online help for details.")) long __cdecl tell( int _FileHandle ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_umask" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_umask_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl umask( int _Mode ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_unlink" ". See online help for details.")) int __cdecl unlink( char const* _FileName ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_write" ". See online help for details.")) int __cdecl write( int _FileHandle, void const* _Buf, unsigned int _MaxCharCount ); #pragma warning(pop) __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\io.h" #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_IO_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: stdint.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\stdint.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\stdint.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 14 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" typedef signed char int8_t; typedef short int16_t; typedef int int32_t; typedef long long int64_t; typedef unsigned char uint8_t; typedef unsigned short uint16_t; typedef unsigned int uint32_t; typedef unsigned long long uint64_t; typedef signed char int_least8_t; typedef short int_least16_t; typedef int int_least32_t; typedef long long int_least64_t; typedef unsigned char uint_least8_t; typedef unsigned short uint_least16_t; typedef unsigned int uint_least32_t; typedef unsigned long long uint_least64_t; typedef signed char int_fast8_t; typedef int int_fast16_t; typedef int int_fast32_t; typedef long long int_fast64_t; typedef unsigned char uint_fast8_t; typedef unsigned int uint_fast16_t; typedef unsigned int uint_fast32_t; typedef unsigned long long uint_fast64_t; typedef long long intmax_t; typedef unsigned long long uintmax_t; #line 60 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" #line 73 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" #line 86 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" #line 96 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdint.h" #line 23 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\stdint.h" #line 47 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\stdint.h" #line 23 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\stdint.h" #line 47 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\stdint.h" #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_STDINT_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: pwd.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "pwd.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "pwd.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: float.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\float.h" #line 1 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #line 59 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #line 80 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #line 96 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #line 109 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #line 125 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #line 138 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #line 179 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #line 203 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" unsigned int __cdecl _clearfp(void); #pragma warning(push) #pragma warning(disable: 4141) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_controlfp_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) unsigned int __cdecl _controlfp( unsigned int _NewValue, unsigned int _Mask ); #pragma warning(pop) void __cdecl _set_controlfp( unsigned int _NewValue, unsigned int _Mask ); errno_t __cdecl _controlfp_s( unsigned int* _CurrentState, unsigned int _NewValue, unsigned int _Mask ); unsigned int __cdecl _statusfp(void); void __cdecl _fpreset(void); #line 268 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" unsigned int __cdecl _control87( unsigned int _NewValue, unsigned int _Mask ); #line 287 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" int* __cdecl __fpecode(void); int __cdecl __fpe_flt_rounds(void); double __cdecl _copysign( double _Number, double _Sign); double __cdecl _chgsign( double _X); double __cdecl _scalb( double _X, long _Y); double __cdecl _logb( double _X); double __cdecl _nextafter( double _X, double _Y); int __cdecl _finite( double _X); int __cdecl _isnan( double _X); int __cdecl _fpclass( double _X); float __cdecl _scalbf( float _X, long _Y); void __cdecl fpreset(void); #line 354 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #line 378 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" #line 390 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\float.h" __pragma(pack(pop)) #line 15 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 48 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" extern int __cdecl __libm_flt_rounds (void) ; #line 84 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 96 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 110 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 121 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 131 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 142 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 150 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 186 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 201 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 273 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 347 "E:\\PROGRA~2\\INTELS~1\\COMPIL~2\\windows\\compiler\\include\\float.h" #line 15 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\float.h" #line 48 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\float.h" #line 349 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\compiler\\include\\float.h" #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_FLOAT_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sys/param.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/param.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/param.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: netdb.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "netdb.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "netdb.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: search.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\search.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __pragma(pack(push, 8)) typedef int (__cdecl* _CoreCrtSecureSearchSortCompareFunction)(void*, void const*, void const*); typedef int (__cdecl* _CoreCrtNonSecureSearchSortCompareFunction)(void const*, void const*); void* __cdecl bsearch_s( void const* _Key, void const* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void __cdecl qsort_s( void* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl bsearch( void const* _Key, void const* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void __cdecl qsort( void* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lfind_s( void const* _Key, void const* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lsearch_s( void const* _Key, void* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); #line 185 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lfind" ". See online help for details.")) void* __cdecl lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lsearch" ". See online help for details.")) void* __cdecl lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\search.h" #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Defined "HAVE_SEARCH_H" to "1" ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sys/procfs.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/procfs.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/procfs.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: sys/resource.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/resource.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sys/resource.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: unistd.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "unistd.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "unistd.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST check from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:77) TESTING: check from config.headers(config/BuildSystem/config/headers.py:77) Checks for "header", and defines HAVE_"header" if found Checking for header: netinet/in.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "netinet/in.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "netinet/in.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST checkRecursiveMacros from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:223) TESTING: checkRecursiveMacros from config.headers(config/BuildSystem/config/headers.py:223) Checks that the preprocessor allows recursive macros, and if not defines HAVE_BROKEN_RECURSIVE_MACRO Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" void a(int i, int j) {} #define a(b) a(b,__LINE__) int main() { a(0); ; return 0; } ================================================================================ TEST configureCacheDetails from config.utilities.cacheDetails(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/cacheDetails.py:78) TESTING: configureCacheDetails from config.utilities.cacheDetails(config/BuildSystem/config/utilities/cacheDetails.py:78) Try to determine the size and associativity of the cache. Pushing language C All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.c(3): catastrophic error: cannot open source file "unistd.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.c (code 4) Possible ERROR while running compiler: exit code 1024 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.c(3): catastrophic error: cannot open source file "unistd.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.c (code 4)Source: #include "confdefs.h" #include "conffix.h" #include long getconf_LEVEL1_DCACHE_SIZE() { long val = sysconf(_SC_LEVEL1_DCACHE_SIZE); return (16 <= val && val <= 2147483647) ? val : 32768; } int main() { ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.c(4): warning #144: a value of type "int" cannot be used to initialize an entity of type "FILE *" long getconf_LEVEL1_DCACHE_SIZE() { long val=-1; FILE *f = popen("getconf LEVEL1_DCACHE_SIZE","r"); fscanf(f,"%ld",&val); pclose(f); return (16 <= val && val <= 2147483647) ? val : 32768; } ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include long getconf_LEVEL1_DCACHE_SIZE() { long val=-1; FILE *f = popen("getconf LEVEL1_DCACHE_SIZE","r"); fscanf(f,"%ld",&val); pclose(f); return (16 <= val && val <= 2147483647) ? val : 32768; } int main() { ; return 0; } Popping language C Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.c(5): warning #144: a value of type "int" cannot be used to initialize an entity of type "FILE *" long getconf_LEVEL1_DCACHE_SIZE() { long val=-1; FILE *f = popen("getconf LEVEL1_DCACHE_SIZE","r"); fscanf(f,"%ld",&val); pclose(f); return (16 <= val && val <= 2147483647) ? val : 32768; } ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #include long getconf_LEVEL1_DCACHE_SIZE() { long val=-1; FILE *f = popen("getconf LEVEL1_DCACHE_SIZE","r"); fscanf(f,"%ld",&val); pclose(f); return (16 <= val && val <= 2147483647) ? val : 32768; } int main() { FILE *output = fopen("conftestval","w"); if (!output) return 1; fprintf(output,"%ld",getconf_LEVEL1_DCACHE_SIZE()); fclose(output);; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol pclose referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.exe : fatal error LNK1120: 2 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol pclose referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.exe : fatal error LNK1120: 2 unresolved externalsCould not determine LEVEL1_DCACHE_SIZE, using default 32768 Popping language C Defined "LEVEL1_DCACHE_SIZE" to "32768" Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.c(5): warning #144: a value of type "int" cannot be used to initialize an entity of type "FILE *" long getconf_LEVEL1_DCACHE_LINESIZE() { long val=-1; FILE *f = popen("getconf LEVEL1_DCACHE_LINESIZE","r"); fscanf(f,"%ld",&val); pclose(f); return (16 <= val && val <= 2147483647) ? val : 32; } ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #include long getconf_LEVEL1_DCACHE_LINESIZE() { long val=-1; FILE *f = popen("getconf LEVEL1_DCACHE_LINESIZE","r"); fscanf(f,"%ld",&val); pclose(f); return (16 <= val && val <= 2147483647) ? val : 32; } int main() { FILE *output = fopen("conftestval","w"); if (!output) return 1; fprintf(output,"%ld",getconf_LEVEL1_DCACHE_LINESIZE()); fclose(output);; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol pclose referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.exe : fatal error LNK1120: 2 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol pclose referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.exe : fatal error LNK1120: 2 unresolved externalsCould not determine LEVEL1_DCACHE_LINESIZE, using default 32 Popping language C Defined "LEVEL1_DCACHE_LINESIZE" to "32" Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.c(5): warning #144: a value of type "int" cannot be used to initialize an entity of type "FILE *" long getconf_LEVEL1_DCACHE_ASSOC() { long val=-1; FILE *f = popen("getconf LEVEL1_DCACHE_ASSOC","r"); fscanf(f,"%ld",&val); pclose(f); return (0 <= val && val <= 2147483647) ? val : 2; } ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #include long getconf_LEVEL1_DCACHE_ASSOC() { long val=-1; FILE *f = popen("getconf LEVEL1_DCACHE_ASSOC","r"); fscanf(f,"%ld",&val); pclose(f); return (0 <= val && val <= 2147483647) ? val : 2; } int main() { FILE *output = fopen("conftestval","w"); if (!output) return 1; fprintf(output,"%ld",getconf_LEVEL1_DCACHE_ASSOC()); fclose(output);; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol pclose referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.exe : fatal error LNK1120: 2 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol pclose referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.cacheDetails\conftest.exe : fatal error LNK1120: 2 unresolved externalsCould not determine LEVEL1_DCACHE_ASSOC, using default 2 Popping language C Defined "LEVEL1_DCACHE_ASSOC" to "2" ================================================================================ TEST check_siginfo_t from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:46) TESTING: check_siginfo_t from config.types(config/BuildSystem/config/types.py:46) Checks if siginfo_t exists in signal.h. This check is for windows, and C89 check. Checking for type: siginfo_t All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(13): error: identifier "siginfo_t" is undefined siginfo_t a;; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(13): error: identifier "siginfo_t" is undefined siginfo_t a;; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { siginfo_t a;; return 0; } siginfo_t found ================================================================================ TEST check__int64 from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:52) TESTING: check__int64 from config.types(config/BuildSystem/config/types.py:52) Checks if __int64 exists. This is primarily for windows. Checking for type: __int64 Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #endif int main() { __int64 a;; return 0; } __int64 found Defined "HAVE___INT64" to "1" ================================================================================ TEST checkSizeTypes from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:58) TESTING: checkSizeTypes from config.types(config/BuildSystem/config/types.py:58) Checks for types associated with sizes, such as size_t. Checking for type: size_t Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #endif int main() { size_t a;; return 0; } size_t found ================================================================================ TEST checkFileTypes from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:68) TESTING: checkFileTypes from config.types(config/BuildSystem/config/types.py:68) Checks for types associated with files, such as mode_t, off_t, etc. Checking for type: mode_t Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(13): error: identifier "mode_t" is undefined mode_t a;; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(13): error: identifier "mode_t" is undefined mode_t a;; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #endif int main() { mode_t a;; return 0; } Typedefed "int" to "mode_t" Checking for type: off_t Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #endif int main() { off_t a;; return 0; } off_t found ================================================================================ TEST checkIntegerTypes from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:63) TESTING: checkIntegerTypes from config.types(config/BuildSystem/config/types.py:63) Checks for types associated with integers, such as int32_t. Checking for type: int32_t Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(13): error: identifier "int32_t" is undefined int32_t a;; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(13): error: identifier "int32_t" is undefined int32_t a;; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #endif int main() { int32_t a;; return 0; } Typedefed "int" to "int32_t" ================================================================================ TEST checkPID from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:74) TESTING: checkPID from config.types(config/BuildSystem/config/types.py:74) Checks for pid_t, and defines it if necessary Checking for type: pid_t Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(13): error: identifier "pid_t" is undefined pid_t a;; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(13): error: identifier "pid_t" is undefined pid_t a;; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #endif int main() { pid_t a;; return 0; } Typedefed "int" to "pid_t" ================================================================================ TEST checkUID from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:78) TESTING: checkUID from config.types(config/BuildSystem/config/types.py:78) Checks for uid_t and gid_t, and defines them if necessary Source: #include "confdefs.h" #include "conffix.h" #include Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.types\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.types\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.types\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.types\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.types\\conftest.c" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\sys/types.h" #pragma once typedef unsigned short _ino_t; typedef _ino_t ino_t; typedef unsigned int _dev_t; typedef _dev_t dev_t; typedef long _off_t; typedef _off_t off_t; #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.types\\conftest.c" Defined "uid_t" to "int" Defined "gid_t" to "int" ================================================================================ TEST checkSignal from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:85) TESTING: checkSignal from config.types(config/BuildSystem/config/types.py:85) Checks the return type of signal() and defines RETSIGTYPE to that type name Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #include #ifdef signal #undef signal #endif #ifdef __cplusplus extern "C" void (*signal (int, void(*)(int)))(int); #else void (*signal())(); #endif int main() { ; return 0; } Defined "RETSIGTYPE" to "void" ================================================================================ TEST checkC99Complex from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:106) TESTING: checkC99Complex from config.types(config/BuildSystem/config/types.py:106) Check for complex numbers in in C99 std Note that since PETSc source code uses _Complex we test specifically for that, not complex Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\include\complex.h(34): warning #1224: #warning directive: "The /Qstd=c99 compilation option is required to enable C99 support for C programs" # warning "The /Qstd=c99 compilation option is required to enable C99 support for C programs" ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(6): error: expected a ";" double _Complex x; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(7): error: identifier "x" is undefined x = I; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(7): error: identifier "I" is undefined x = I; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c E:\Program Files (x86)\IntelSWTools\compilers_and_libraries\windows\compiler\include\complex.h(34): warning #1224: #warning directive: "The /Qstd=c99 compilation option is required to enable C99 support for C programs" # warning "The /Qstd=c99 compilation option is required to enable C99 support for C programs" ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(6): error: expected a ";" double _Complex x; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(7): error: identifier "x" is undefined x = I; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(7): error: identifier "I" is undefined x = I; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { double _Complex x; x = I; ; return 0; } ================================================================================ TEST checkCxxComplex from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:117) TESTING: checkCxxComplex from config.types(config/BuildSystem/config/types.py:117) Check for complex numbers in namespace std Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { std::complex x; ; return 0; } Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Defined "HAVE_CXX_COMPLEX" to "1" Popping language Cxx ================================================================================ TEST checkFortranKind from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:138) TESTING: checkFortranKind from config.types(config/BuildSystem/config/types.py:138) Checks whether selected_int_kind etc work USE_FORTRANKIND Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.F90 Successful compile: Source: program main integer(kind=selected_int_kind(10)) i real(kind=selected_real_kind(10)) d end Defined "USE_FORTRANKIND" to "1" Popping language FC ================================================================================ TEST checkConst from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:150) TESTING: checkConst from config.types(config/BuildSystem/config/types.py:150) Checks for working const, and if not found defines it to empty string Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(25): warning #592: variable "x" is used before its value is set if (x[0]); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(30): warning #592: variable "t" is used before its value is set *t++ = 0; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(46): warning #592: variable "b" is used before its value is set struct s *b; b->j = 5; ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { /* Ultrix mips cc rejects this. */ typedef int charset[2]; const charset x; /* SunOS 4.1.1 cc rejects this. */ char const *const *ccp; char **p; /* NEC SVR4.0.2 mips cc rejects this. */ struct point {int x, y;}; static struct point const zero = {0,0}; /* AIX XL C 1.02.0.0 rejects this. It does not let you subtract one const X* pointer from another in an arm of an if-expression whose if-part is not a constant expression */ const char *g = "string"; ccp = &g + (g ? g-g : 0); /* HPUX 7.0 cc rejects these. */ ++ccp; p = (char**) ccp; ccp = (char const *const *) p; /* This section avoids unused variable warnings */ if (zero.x); if (x[0]); { /* SCO 3.2v4 cc rejects this. */ char *t; char const *s = 0 ? (char *) 0 : (char const *) 0; *t++ = 0; if (*s); } { /* Someone thinks the Sun supposedly-ANSI compiler will reject this. */ int x[] = {25, 17}; const int *foo = &x[0]; ++foo; } { /* Sun SC1.0 ANSI compiler rejects this -- but not the above. */ typedef const int *iptr; iptr p = 0; ++p; } { /* AIX XL C 1.02.0.0 rejects this saying "k.c", line 2.27: 1506-025 (S) Operand must be a modifiable lvalue. */ struct s { int j; const int *ap[3]; }; struct s *b; b->j = 5; } { /* ULTRIX-32 V3.1 (Rev 9) vcc rejects this */ const int foo = 10; /* Get rid of unused variable warning */ if (foo); } ; return 0; } ================================================================================ TEST checkEndian from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:206) TESTING: checkEndian from config.types(config/BuildSystem/config/types.py:206) If the machine is big endian, defines WORDS_BIGENDIAN Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(11): error: identifier "bogus" is undefined bogus endian macros ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(11): error: expected a ";" bogus endian macros ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(11): error: identifier "bogus" is undefined bogus endian macros ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c(11): error: expected a ";" bogus endian macros ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.types\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include #ifdef HAVE_SYS_PARAM_H #include #endif int main() { #if !BYTE_ORDER || !BIG_ENDIAN || !LITTLE_ENDIAN bogus endian macros #endif ; return 0; } Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { /* Are we little or big endian? From Harbison&Steele. */ union { long l; char c[sizeof(long)]; } u; u.l = 1; exit(u.c[sizeof(long) - 1] == 1); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C ================================================================================ TEST checkSizeof from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:259) TESTING: checkSizeof from config.types(config/BuildSystem/config/types.py:259) Determines the size of type "typeName", and defines SIZEOF_"typeName" to be the size Checking for size of type: char Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(char)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_CHAR" to "1" ================================================================================ TEST checkSizeof from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:259) TESTING: checkSizeof from config.types(config/BuildSystem/config/types.py:259) Determines the size of type "typeName", and defines SIZEOF_"typeName" to be the size Checking for size of type: void * Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(void *)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_VOID_P" to "8" ================================================================================ TEST checkSizeof from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:259) TESTING: checkSizeof from config.types(config/BuildSystem/config/types.py:259) Determines the size of type "typeName", and defines SIZEOF_"typeName" to be the size Checking for size of type: short Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(short)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_SHORT" to "2" ================================================================================ TEST checkSizeof from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:259) TESTING: checkSizeof from config.types(config/BuildSystem/config/types.py:259) Determines the size of type "typeName", and defines SIZEOF_"typeName" to be the size Checking for size of type: int Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(int)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_INT" to "4" ================================================================================ TEST checkSizeof from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:259) TESTING: checkSizeof from config.types(config/BuildSystem/config/types.py:259) Determines the size of type "typeName", and defines SIZEOF_"typeName" to be the size Checking for size of type: long Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(long)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_LONG" to "4" ================================================================================ TEST checkSizeof from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:259) TESTING: checkSizeof from config.types(config/BuildSystem/config/types.py:259) Determines the size of type "typeName", and defines SIZEOF_"typeName" to be the size Checking for size of type: long long Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(long long)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_LONG_LONG" to "8" ================================================================================ TEST checkSizeof from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:259) TESTING: checkSizeof from config.types(config/BuildSystem/config/types.py:259) Determines the size of type "typeName", and defines SIZEOF_"typeName" to be the size Checking for size of type: float Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(float)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_FLOAT" to "4" ================================================================================ TEST checkSizeof from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:259) TESTING: checkSizeof from config.types(config/BuildSystem/config/types.py:259) Determines the size of type "typeName", and defines SIZEOF_"typeName" to be the size Checking for size of type: double Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(double)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_DOUBLE" to "8" ================================================================================ TEST checkSizeof from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:259) TESTING: checkSizeof from config.types(config/BuildSystem/config/types.py:259) Determines the size of type "typeName", and defines SIZEOF_"typeName" to be the size Checking for size of type: size_t Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(size_t)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_SIZE_T" to "8" ================================================================================ TEST checkBitsPerByte from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:310) TESTING: checkBitsPerByte from config.types(config/BuildSystem/config/types.py:310) Determine the nubmer of bits per byte and define BITS_PER_BYTE Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #if STDC_HEADERS #include #include #endif int main() { FILE *f = fopen("conftestval", "w"); char val[2]; int i = 0; if (!f) exit(1); val[0]='\1'; val[1]='\0'; while(val[0]) {val[0] <<= 1; i++;} fprintf(f, "%d\n", i); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Defined "BITS_PER_BYTE" to "8" ================================================================================ TEST checkVisibility from config.types(/home/alireza/petsc-3.9.3/config/BuildSystem/config/types.py:356) TESTING: checkVisibility from config.types(config/BuildSystem/config/types.py:356) Disabled visibility attributes due to static build================================================================================ TEST configureMemAlign from PETSc.options.memAlign(/home/alireza/petsc-3.9.3/config/PETSc/options/memAlign.py:30) TESTING: configureMemAlign from PETSc.options.memAlign(config/PETSc/options/memAlign.py:30) Choose alignment Defined "MEMALIGN" to "16" Memory alignment is 16 ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [socket] in library ['socket', 'nsl'] [] Pushing language C All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char socket(); static void _check_socket() { socket(); } int main() { _check_socket();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -lsocket -lnsl stdout: ipo: error #11018: Cannot open libsocket.lib ipo: error #11018: Cannot open libnsl.lib LINK : fatal error LNK1181: cannot open input file 'libsocket.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libsocket.lib ipo: error #11018: Cannot open libnsl.lib LINK : fatal error LNK1181: cannot open input file 'libsocket.lib' Popping language C ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [handle_sigfpes] in library ['fpe'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char handle_sigfpes(); static void _check_handle_sigfpes() { handle_sigfpes(); } int main() { _check_handle_sigfpes();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -lfpe stdout: ipo: error #11018: Cannot open libfpe.lib LINK : fatal error LNK1181: cannot open input file 'libfpe.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libfpe.lib LINK : fatal error LNK1181: cannot open input file 'libfpe.lib' Popping language C ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [socket] in library ['socket', 'nsl'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char socket(); static void _check_socket() { socket(); } int main() { _check_socket();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -lsocket -lnsl stdout: ipo: error #11018: Cannot open libsocket.lib ipo: error #11018: Cannot open libnsl.lib LINK : fatal error LNK1181: cannot open input file 'libsocket.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libsocket.lib ipo: error #11018: Cannot open libnsl.lib LINK : fatal error LNK1181: cannot open input file 'libsocket.lib' Popping language C ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [handle_sigfpes] in library ['fpe'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char handle_sigfpes(); static void _check_handle_sigfpes() { handle_sigfpes(); } int main() { _check_handle_sigfpes();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -lfpe stdout: ipo: error #11018: Cannot open libfpe.lib LINK : fatal error LNK1181: cannot open input file 'libfpe.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libfpe.lib LINK : fatal error LNK1181: cannot open input file 'libfpe.lib' Popping language C ================================================================================ TEST checkMath from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:260) TESTING: checkMath from config.libraries(config/BuildSystem/config/libraries.py:260) Check for sin() in libm, the math library Checking for functions [sin floor log10 pow] in library [''] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ #include double sin(double); static void _check_sin() { double x,y; scanf("%lf",&x); y = sin(x); printf("%f",y); ; } #include double floor(double); static void _check_floor() { double x,y; scanf("%lf",&x); y = floor(x); printf("%f",y); ; } #include double log10(double); static void _check_log10() { double x,y; scanf("%lf",&x); y = log10(x); printf("%f",y); ; } #include double pow(double, double); static void _check_pow() { double x,y; scanf("%lf",&x); y = pow(x,x); printf("%f",y); ; } int main() { _check_sin(); _check_floor(); _check_log10(); _check_pow();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o Popping language C CheckMath: using math library [] ================================================================================ TEST checkMathErf from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:279) TESTING: checkMathErf from config.libraries(config/BuildSystem/config/libraries.py:279) Check for erf() in libm, the math library Checking for functions [erf] in library [] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ #include static void _check_erf() { double (*checkErf)(double) = erf;double x = 0,y; y = (*checkErf)(x); } int main() { _check_erf();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o Popping language C erf() found Defined "HAVE_ERF" to "1" ================================================================================ TEST checkMathTgamma from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:288) TESTING: checkMathTgamma from config.libraries(config/BuildSystem/config/libraries.py:288) Check for tgamma() in libm, the math library Checking for functions [tgamma] in library [] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ #include static void _check_tgamma() { double (*checkTgamma)(double) = tgamma;double x = 0,y; y = (*checkTgamma)(x); } int main() { _check_tgamma();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o Popping language C tgamma() found Defined "HAVE_TGAMMA" to "1" ================================================================================ TEST checkMathFenv from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:297) TESTING: checkMathFenv from config.libraries(config/BuildSystem/config/libraries.py:297) Checks if can be used with FE_DFL_ENV Checking for functions [fesetenv] in library [] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ #include static void _check_fesetenv() { fesetenv(FE_DFL_ENV);; } int main() { _check_fesetenv();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o Popping language C Defined "HAVE_FENV_H" to "1" ================================================================================ TEST checkMathLog2 from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:305) TESTING: checkMathLog2 from config.libraries(config/BuildSystem/config/libraries.py:305) Check for log2() in libm, the math library Checking for functions [log2] in library [] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ #include static void _check_log2() { double (*checkLog2)(double) = log2; double x = 2.5, y = (*checkLog2)(x); } int main() { _check_log2();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o Popping language C log2() found Defined "HAVE_LOG2" to "1" ================================================================================ TEST checkRealtime from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:314) TESTING: checkRealtime from config.libraries(config/BuildSystem/config/libraries.py:314) Check for presence of clock_gettime() in realtime library (POSIX Realtime extensions) Checking for functions [clock_gettime] in library [''] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c(5): error: identifier "CLOCK_REALTIME" is undefined static void _check_clock_gettime() { struct timespec tp; clock_gettime(CLOCK_REALTIME,&tp);; } ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c(5): error: identifier "CLOCK_REALTIME" is undefined static void _check_clock_gettime() { struct timespec tp; clock_gettime(CLOCK_REALTIME,&tp);; } ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ #include static void _check_clock_gettime() { struct timespec tp; clock_gettime(CLOCK_REALTIME,&tp);; } int main() { _check_clock_gettime();; return 0; } Compile failed inside link Popping language C Checking for functions [clock_gettime] in library ['rt'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c(5): error: identifier "CLOCK_REALTIME" is undefined static void _check_clock_gettime() { struct timespec tp; clock_gettime(CLOCK_REALTIME,&tp);; } ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c(5): error: identifier "CLOCK_REALTIME" is undefined static void _check_clock_gettime() { struct timespec tp; clock_gettime(CLOCK_REALTIME,&tp);; } ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ #include static void _check_clock_gettime() { struct timespec tp; clock_gettime(CLOCK_REALTIME,&tp);; } int main() { _check_clock_gettime();; return 0; } Compile failed inside link Popping language C Warning: No realtime library found ================================================================================ TEST checkDynamic from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:330) TESTING: checkDynamic from config.libraries(config/BuildSystem/config/libraries.py:330) Check for the header and libraries necessary for dynamic library manipulation Checking for functions [dlopen] in library ['dl'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char dlopen(); static void _check_dlopen() { dlopen(); } int main() { _check_dlopen();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -ldl stdout: ipo: error #11018: Cannot open libdl.lib LINK : fatal error LNK1181: cannot open input file 'libdl.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libdl.lib LINK : fatal error LNK1181: cannot open input file 'libdl.lib' Popping language C Checking for header: dlfcn.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "dlfcn.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "dlfcn.h" #include ^ #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST configureLibraryOptions from PETSc.options.libraryOptions(/home/alireza/petsc-3.9.3/config/PETSc/options/libraryOptions.py:38) TESTING: configureLibraryOptions from PETSc.options.libraryOptions(config/PETSc/options/libraryOptions.py:38) Sets PETSC_USE_DEBUG, PETSC_USE_INFO, PETSC_USE_LOG, PETSC_USE_CTABLE, PETSC_USE_FORTRAN_KERNELS, and PETSC_USE_AVX512_KERNELS Defined "USE_LOG" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -qversion stdout: icl: command line warning #10006: ignoring unknown option '/qversion' icl: command line error: no files specified; for help type "icl /help" Defined "USE_MALLOC_COALESCED" to "1" Defined "USE_INFO" to "1" Defined "USE_CTABLE" to "1" Defined "USE_BACKWARD_LOOP" to "1" **********Checking if running on BGL/IBM detected Checking for functions [bgl_perfctr_void] in library [''] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char bgl_perfctr_void(); static void _check_bgl_perfctr_void() { bgl_perfctr_void(); } int main() { _check_bgl_perfctr_void();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol bgl_perfctr_void referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol bgl_perfctr_void referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C Checking for functions [ADIOI_BGL_Open] in library [''] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char ADIOI_BGL_Open(); static void _check_ADIOI_BGL_Open() { ADIOI_BGL_Open(); } int main() { _check_ADIOI_BGL_Open();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol ADIOI_BGL_Open referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol ADIOI_BGL_Open referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C *********BGL/IBM test failure Defined "Alignx(a,b)" to " " ================================================================================ TEST configureISColorValueType from PETSc.options.libraryOptions(/home/alireza/petsc-3.9.3/config/PETSc/options/libraryOptions.py:96) TESTING: configureISColorValueType from PETSc.options.libraryOptions(config/PETSc/options/libraryOptions.py:96) Sets PETSC_IS_COLOR_VALUE_TYPE, MPIU_COLORING_VALUE, IS_COLORING_MAX required by ISColor Defined "MPIU_COLORING_VALUE" to "MPI_UNSIGNED_SHORT" Defined "IS_COLORING_MAX" to "65535" Defined "IS_COLOR_VALUE_TYPE" to "short" Defined "IS_COLOR_VALUE_TYPE_F" to "integer2" ================================================================================ TEST configureCPURelax from config.atomics(/home/alireza/petsc-3.9.3/config/BuildSystem/config/atomics.py:17) TESTING: configureCPURelax from config.atomics(config/BuildSystem/config/atomics.py:17) Definitions for cpu relax assembly instructions All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "asm" is undefined asm volatile("rep; nop" ::: "memory");; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: expected a ";" asm volatile("rep; nop" ::: "memory");; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "asm" is undefined asm volatile("rep; nop" ::: "memory");; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: expected a ";" asm volatile("rep; nop" ::: "memory");; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" int main() { asm volatile("rep; nop" ::: "memory");; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "HMT_low" is undefined do { HMT_low; HMT_medium; __asm__ __volatile__ ("":::"memory"); } while (0); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "HMT_medium" is undefined do { HMT_low; HMT_medium; __asm__ __volatile__ ("":::"memory"); } while (0); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "HMT_low" is undefined do { HMT_low; HMT_medium; __asm__ __volatile__ ("":::"memory"); } while (0); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "HMT_medium" is undefined do { HMT_low; HMT_medium; __asm__ __volatile__ ("":::"memory"); } while (0); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" int main() { do { HMT_low; HMT_medium; __asm__ __volatile__ ("":::"memory"); } while (0); return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" int main() { __asm__ __volatile__ ("":::"memory");; return 0; } Defined "CPU_RELAX()" to "__asm__ __volatile__ ("":::"memory")" ================================================================================ TEST configureMemoryBarriers from config.atomics(/home/alireza/petsc-3.9.3/config/BuildSystem/config/atomics.py:36) TESTING: configureMemoryBarriers from config.atomics(config/BuildSystem/config/atomics.py:36) Definitions for memory barrier instructions Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "asm" is undefined asm volatile("mfence":::"memory"); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: expected a ";" asm volatile("mfence":::"memory"); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "asm" is undefined asm volatile("mfence":::"memory"); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: expected a ";" asm volatile("mfence":::"memory"); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" int main() { asm volatile("mfence":::"memory"); return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "asm" is undefined asm volatile("lfence":::"memory"); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: expected a ";" asm volatile("lfence":::"memory"); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "asm" is undefined asm volatile("lfence":::"memory"); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: expected a ";" asm volatile("lfence":::"memory"); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" int main() { asm volatile("lfence":::"memory"); return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "asm" is undefined asm volatile("sfence":::"memory"); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: expected a ";" asm volatile("sfence":::"memory"); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: identifier "asm" is undefined asm volatile("sfence":::"memory"); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c(5): error: expected a ";" asm volatile("sfence":::"memory"); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.atomics\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" int main() { asm volatile("sfence":::"memory"); return 0; } ================================================================================ TEST checkMemcmp from config.functions(/home/alireza/petsc-3.9.3/config/BuildSystem/config/functions.py:110) TESTING: checkMemcmp from config.functions(config/BuildSystem/config/functions.py:110) Check for 8-bit clean memcmp Making executable to test memcmp() All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include void exit(int); int main() { char c0 = 0x40; char c1 = (char) 0x80; char c2 = (char) 0x81; exit(memcmp(&c0, &c2, 1) < 0 && memcmp(&c1, &c2, 1) < 0 ? 0 : 1); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe ================================================================================ TEST checkSysinfo from config.functions(/home/alireza/petsc-3.9.3/config/BuildSystem/config/functions.py:135) TESTING: checkSysinfo from config.functions(config/BuildSystem/config/functions.py:135) Check whether sysinfo takes three arguments, and if it does define HAVE_SYSINFO_3ARG Checking for functions [sysinfo] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char sysinfo(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_sysinfo) || defined (__stub___sysinfo) sysinfo_will_always_fail_with_ENOSYS(); #else sysinfo(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol sysinfo referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol sysinfo referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals================================================================================ TEST checkVPrintf from config.functions(/home/alireza/petsc-3.9.3/config/BuildSystem/config/functions.py:158) TESTING: checkVPrintf from config.functions(config/BuildSystem/config/functions.py:158) Checks whether vprintf requires a char * last argument, and if it does defines HAVE_VPRINTF_CHAR Checking for functions [vprintf] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char vprintf(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_vprintf) || defined (__stub___vprintf) vprintf_will_always_fail_with_ENOSYS(); #else vprintf(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol vprintf referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol vprintf referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsExecuting: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(8): warning #592: variable "Argp" is used before its value is set vprintf( "%d", Argp ); ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #include int main() { va_list Argp; vprintf( "%d", Argp ); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o ================================================================================ TEST checkVFPrintf from config.functions(/home/alireza/petsc-3.9.3/config/BuildSystem/config/functions.py:165) TESTING: checkVFPrintf from config.functions(config/BuildSystem/config/functions.py:165) Checks whether vfprintf requires a char * last argument, and if it does defines HAVE_VFPRINTF_CHAR Checking for functions [vfprintf] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char vfprintf(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_vfprintf) || defined (__stub___vfprintf) vfprintf_will_always_fail_with_ENOSYS(); #else vfprintf(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol vfprintf referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol vfprintf referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsExecuting: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(8): warning #592: variable "Argp" is used before its value is set vfprintf(stdout, "%d", Argp ); ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #include int main() { va_list Argp; vfprintf(stdout, "%d", Argp ); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o ================================================================================ TEST checkVSNPrintf from config.functions(/home/alireza/petsc-3.9.3/config/BuildSystem/config/functions.py:172) TESTING: checkVSNPrintf from config.functions(config/BuildSystem/config/functions.py:172) Checks whether vsnprintf requires a char * last argument, and if it does defines HAVE_VSNPRINTF_CHAR Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { _vsnprintf(0,0,0,0); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE__VSNPRINTF" to "1" ================================================================================ TEST checkNanosleep from config.functions(/home/alireza/petsc-3.9.3/config/BuildSystem/config/functions.py:206) TESTING: checkNanosleep from config.functions(config/BuildSystem/config/functions.py:206) Check for functional nanosleep() - as time.h behaves differently for different compiler flags - like -std=c89 Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { struct timespec tp; tp.tv_sec = 0; tp.tv_nsec = (long)(1e9); nanosleep(&tp,0); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol nanosleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol nanosleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals================================================================================ TEST checkSignalHandlerType from config.functions(/home/alireza/petsc-3.9.3/config/BuildSystem/config/functions.py:182) TESTING: checkSignalHandlerType from config.functions(config/BuildSystem/config/functions.py:182) Checks the type of C++ signals handlers, and defines SIGNAL_CAST to the correct value Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include static void myhandler(int sig) {} int main() { signal(SIGFPE,myhandler); ; return 0; } Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "SIGNAL_CAST" to " " Popping language Cxx ================================================================================ TEST checkFreeReturnType from config.functions(/home/alireza/petsc-3.9.3/config/BuildSystem/config/functions.py:192) TESTING: checkFreeReturnType from config.functions(config/BuildSystem/config/functions.py:192) Checks whether free returns void or int, and defines HAVE_FREE_RETURN_INT Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(6): warning #592: variable "p" is used before its value is set int ierr; void *p; ierr = free(p); return 0; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(6): error: a value of type "void" cannot be assigned to an entity of type "int" int ierr; void *p; ierr = free(p); return 0; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(6): warning #592: variable "p" is used before its value is set int ierr; void *p; ierr = free(p); return 0; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(6): error: a value of type "void" cannot be assigned to an entity of type "int" int ierr; void *p; ierr = free(p); return 0; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int ierr; void *p; ierr = free(p); return 0; ; return 0; } Compile failed inside link ================================================================================ TEST checkVariableArgumentLists from config.functions(/home/alireza/petsc-3.9.3/config/BuildSystem/config/functions.py:198) TESTING: checkVariableArgumentLists from config.functions(config/BuildSystem/config/functions.py:198) Checks whether the variable argument list functionality is working Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(7): warning #592: variable "l2" is used before its value is set va_copy(l1, l2); ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { va_list l1, l2; va_copy(l1, l2); return 0; ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE_VA_COPY" to "1" ================================================================================ TEST checkClassify from config.functions(/home/alireza/petsc-3.9.3/config/BuildSystem/config/functions.py:89) TESTING: checkClassify from config.functions(config/BuildSystem/config/functions.py:89) Recursive decompose to rapidly classify functions as found or missing To confirm that a function is missing, we require a compile/link failure with only that function in a compilation unit. In contrast, we can confirm that many functions are present by compiling them all together in a large compilation unit. We optimistically compile everything together, then trim all functions that were named in the error message and bisect the result. The trimming is only an optimization to increase the likelihood of a big-batch compile succeeding; we do not rely on the compiler naming missing functions. Checking for functions [rand getdomainname _sleep snprintf realpath dlsym bzero _getcwd getwd uname _lseek sleep _access lseek usleep dlclose gethostname clock get_nprocs access _snprintf dlerror mkstemp fork getpagesize sbreak memalign sigset getcwd gethostbyname gettimeofday readlink _set_output_format PXFGETARG sigaction strcasecmp dlopen drand48 socket memmove signal popen getrusage times _mkdir time sysctlbyname stricmp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char rand(); char getdomainname(); char _sleep(); char snprintf(); char realpath(); char dlsym(); char bzero(); char _getcwd(); char getwd(); char uname(); char _lseek(); char sleep(); char _access(); char lseek(); char usleep(); char dlclose(); char gethostname(); char clock(); char get_nprocs(); char access(); char _snprintf(); char dlerror(); char mkstemp(); char fork(); char getpagesize(); char sbreak(); char memalign(); char sigset(); char getcwd(); char gethostbyname(); char gettimeofday(); char readlink(); char _set_output_format(); char PXFGETARG(); char sigaction(); char strcasecmp(); char dlopen(); char drand48(); char socket(); char memmove(); char signal(); char popen(); char getrusage(); char times(); char _mkdir(); char time(); char sysctlbyname(); char stricmp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_rand) || defined (__stub___rand) rand_will_always_fail_with_ENOSYS(); #else rand(); #endif #if defined (__stub_getdomainname) || defined (__stub___getdomainname) getdomainname_will_always_fail_with_ENOSYS(); #else getdomainname(); #endif #if defined (__stub__sleep) || defined (__stub____sleep) _sleep_will_always_fail_with_ENOSYS(); #else _sleep(); #endif #if defined (__stub_snprintf) || defined (__stub___snprintf) snprintf_will_always_fail_with_ENOSYS(); #else snprintf(); #endif #if defined (__stub_realpath) || defined (__stub___realpath) realpath_will_always_fail_with_ENOSYS(); #else realpath(); #endif #if defined (__stub_dlsym) || defined (__stub___dlsym) dlsym_will_always_fail_with_ENOSYS(); #else dlsym(); #endif #if defined (__stub_bzero) || defined (__stub___bzero) bzero_will_always_fail_with_ENOSYS(); #else bzero(); #endif #if defined (__stub__getcwd) || defined (__stub____getcwd) _getcwd_will_always_fail_with_ENOSYS(); #else _getcwd(); #endif #if defined (__stub_getwd) || defined (__stub___getwd) getwd_will_always_fail_with_ENOSYS(); #else getwd(); #endif #if defined (__stub_uname) || defined (__stub___uname) uname_will_always_fail_with_ENOSYS(); #else uname(); #endif #if defined (__stub__lseek) || defined (__stub____lseek) _lseek_will_always_fail_with_ENOSYS(); #else _lseek(); #endif #if defined (__stub_sleep) || defined (__stub___sleep) sleep_will_always_fail_with_ENOSYS(); #else sleep(); #endif #if defined (__stub__access) || defined (__stub____access) _access_will_always_fail_with_ENOSYS(); #else _access(); #endif #if defined (__stub_lseek) || defined (__stub___lseek) lseek_will_always_fail_with_ENOSYS(); #else lseek(); #endif #if defined (__stub_usleep) || defined (__stub___usleep) usleep_will_always_fail_with_ENOSYS(); #else usleep(); #endif #if defined (__stub_dlclose) || defined (__stub___dlclose) dlclose_will_always_fail_with_ENOSYS(); #else dlclose(); #endif #if defined (__stub_gethostname) || defined (__stub___gethostname) gethostname_will_always_fail_with_ENOSYS(); #else gethostname(); #endif #if defined (__stub_clock) || defined (__stub___clock) clock_will_always_fail_with_ENOSYS(); #else clock(); #endif #if defined (__stub_get_nprocs) || defined (__stub___get_nprocs) get_nprocs_will_always_fail_with_ENOSYS(); #else get_nprocs(); #endif #if defined (__stub_access) || defined (__stub___access) access_will_always_fail_with_ENOSYS(); #else access(); #endif #if defined (__stub__snprintf) || defined (__stub____snprintf) _snprintf_will_always_fail_with_ENOSYS(); #else _snprintf(); #endif #if defined (__stub_dlerror) || defined (__stub___dlerror) dlerror_will_always_fail_with_ENOSYS(); #else dlerror(); #endif #if defined (__stub_mkstemp) || defined (__stub___mkstemp) mkstemp_will_always_fail_with_ENOSYS(); #else mkstemp(); #endif #if defined (__stub_fork) || defined (__stub___fork) fork_will_always_fail_with_ENOSYS(); #else fork(); #endif #if defined (__stub_getpagesize) || defined (__stub___getpagesize) getpagesize_will_always_fail_with_ENOSYS(); #else getpagesize(); #endif #if defined (__stub_sbreak) || defined (__stub___sbreak) sbreak_will_always_fail_with_ENOSYS(); #else sbreak(); #endif #if defined (__stub_memalign) || defined (__stub___memalign) memalign_will_always_fail_with_ENOSYS(); #else memalign(); #endif #if defined (__stub_sigset) || defined (__stub___sigset) sigset_will_always_fail_with_ENOSYS(); #else sigset(); #endif #if defined (__stub_getcwd) || defined (__stub___getcwd) getcwd_will_always_fail_with_ENOSYS(); #else getcwd(); #endif #if defined (__stub_gethostbyname) || defined (__stub___gethostbyname) gethostbyname_will_always_fail_with_ENOSYS(); #else gethostbyname(); #endif #if defined (__stub_gettimeofday) || defined (__stub___gettimeofday) gettimeofday_will_always_fail_with_ENOSYS(); #else gettimeofday(); #endif #if defined (__stub_readlink) || defined (__stub___readlink) readlink_will_always_fail_with_ENOSYS(); #else readlink(); #endif #if defined (__stub__set_output_format) || defined (__stub____set_output_format) _set_output_format_will_always_fail_with_ENOSYS(); #else _set_output_format(); #endif #if defined (__stub_PXFGETARG) || defined (__stub___PXFGETARG) PXFGETARG_will_always_fail_with_ENOSYS(); #else PXFGETARG(); #endif #if defined (__stub_sigaction) || defined (__stub___sigaction) sigaction_will_always_fail_with_ENOSYS(); #else sigaction(); #endif #if defined (__stub_strcasecmp) || defined (__stub___strcasecmp) strcasecmp_will_always_fail_with_ENOSYS(); #else strcasecmp(); #endif #if defined (__stub_dlopen) || defined (__stub___dlopen) dlopen_will_always_fail_with_ENOSYS(); #else dlopen(); #endif #if defined (__stub_drand48) || defined (__stub___drand48) drand48_will_always_fail_with_ENOSYS(); #else drand48(); #endif #if defined (__stub_socket) || defined (__stub___socket) socket_will_always_fail_with_ENOSYS(); #else socket(); #endif #if defined (__stub_memmove) || defined (__stub___memmove) memmove_will_always_fail_with_ENOSYS(); #else memmove(); #endif #if defined (__stub_signal) || defined (__stub___signal) signal_will_always_fail_with_ENOSYS(); #else signal(); #endif #if defined (__stub_popen) || defined (__stub___popen) popen_will_always_fail_with_ENOSYS(); #else popen(); #endif #if defined (__stub_getrusage) || defined (__stub___getrusage) getrusage_will_always_fail_with_ENOSYS(); #else getrusage(); #endif #if defined (__stub_times) || defined (__stub___times) times_will_always_fail_with_ENOSYS(); #else times(); #endif #if defined (__stub__mkdir) || defined (__stub____mkdir) _mkdir_will_always_fail_with_ENOSYS(); #else _mkdir(); #endif #if defined (__stub_time) || defined (__stub___time) time_will_always_fail_with_ENOSYS(); #else time(); #endif #if defined (__stub_sysctlbyname) || defined (__stub___sysctlbyname) sysctlbyname_will_always_fail_with_ENOSYS(); #else sysctlbyname(); #endif #if defined (__stub_stricmp) || defined (__stub___stricmp) stricmp_will_always_fail_with_ENOSYS(); #else stricmp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main conftest.obj : error LNK2019: unresolved external symbol times referenced in function main conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 34 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main conftest.obj : error LNK2019: unresolved external symbol times referenced in function main conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 34 unresolved externalsChecking for functions [rand getdomainname _sleep snprintf realpath dlsym bzero _getcwd getwd uname _lseek sleep _access lseek usleep dlclose gethostname clock get_nprocs access _snprintf dlerror mkstemp fork] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char rand(); char getdomainname(); char _sleep(); char snprintf(); char realpath(); char dlsym(); char bzero(); char _getcwd(); char getwd(); char uname(); char _lseek(); char sleep(); char _access(); char lseek(); char usleep(); char dlclose(); char gethostname(); char clock(); char get_nprocs(); char access(); char _snprintf(); char dlerror(); char mkstemp(); char fork(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_rand) || defined (__stub___rand) rand_will_always_fail_with_ENOSYS(); #else rand(); #endif #if defined (__stub_getdomainname) || defined (__stub___getdomainname) getdomainname_will_always_fail_with_ENOSYS(); #else getdomainname(); #endif #if defined (__stub__sleep) || defined (__stub____sleep) _sleep_will_always_fail_with_ENOSYS(); #else _sleep(); #endif #if defined (__stub_snprintf) || defined (__stub___snprintf) snprintf_will_always_fail_with_ENOSYS(); #else snprintf(); #endif #if defined (__stub_realpath) || defined (__stub___realpath) realpath_will_always_fail_with_ENOSYS(); #else realpath(); #endif #if defined (__stub_dlsym) || defined (__stub___dlsym) dlsym_will_always_fail_with_ENOSYS(); #else dlsym(); #endif #if defined (__stub_bzero) || defined (__stub___bzero) bzero_will_always_fail_with_ENOSYS(); #else bzero(); #endif #if defined (__stub__getcwd) || defined (__stub____getcwd) _getcwd_will_always_fail_with_ENOSYS(); #else _getcwd(); #endif #if defined (__stub_getwd) || defined (__stub___getwd) getwd_will_always_fail_with_ENOSYS(); #else getwd(); #endif #if defined (__stub_uname) || defined (__stub___uname) uname_will_always_fail_with_ENOSYS(); #else uname(); #endif #if defined (__stub__lseek) || defined (__stub____lseek) _lseek_will_always_fail_with_ENOSYS(); #else _lseek(); #endif #if defined (__stub_sleep) || defined (__stub___sleep) sleep_will_always_fail_with_ENOSYS(); #else sleep(); #endif #if defined (__stub__access) || defined (__stub____access) _access_will_always_fail_with_ENOSYS(); #else _access(); #endif #if defined (__stub_lseek) || defined (__stub___lseek) lseek_will_always_fail_with_ENOSYS(); #else lseek(); #endif #if defined (__stub_usleep) || defined (__stub___usleep) usleep_will_always_fail_with_ENOSYS(); #else usleep(); #endif #if defined (__stub_dlclose) || defined (__stub___dlclose) dlclose_will_always_fail_with_ENOSYS(); #else dlclose(); #endif #if defined (__stub_gethostname) || defined (__stub___gethostname) gethostname_will_always_fail_with_ENOSYS(); #else gethostname(); #endif #if defined (__stub_clock) || defined (__stub___clock) clock_will_always_fail_with_ENOSYS(); #else clock(); #endif #if defined (__stub_get_nprocs) || defined (__stub___get_nprocs) get_nprocs_will_always_fail_with_ENOSYS(); #else get_nprocs(); #endif #if defined (__stub_access) || defined (__stub___access) access_will_always_fail_with_ENOSYS(); #else access(); #endif #if defined (__stub__snprintf) || defined (__stub____snprintf) _snprintf_will_always_fail_with_ENOSYS(); #else _snprintf(); #endif #if defined (__stub_dlerror) || defined (__stub___dlerror) dlerror_will_always_fail_with_ENOSYS(); #else dlerror(); #endif #if defined (__stub_mkstemp) || defined (__stub___mkstemp) mkstemp_will_always_fail_with_ENOSYS(); #else mkstemp(); #endif #if defined (__stub_fork) || defined (__stub___fork) fork_will_always_fail_with_ENOSYS(); #else fork(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 16 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 16 unresolved externalsChecking for functions [rand getdomainname _sleep snprintf realpath dlsym bzero _getcwd getwd uname _lseek sleep] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char rand(); char getdomainname(); char _sleep(); char snprintf(); char realpath(); char dlsym(); char bzero(); char _getcwd(); char getwd(); char uname(); char _lseek(); char sleep(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_rand) || defined (__stub___rand) rand_will_always_fail_with_ENOSYS(); #else rand(); #endif #if defined (__stub_getdomainname) || defined (__stub___getdomainname) getdomainname_will_always_fail_with_ENOSYS(); #else getdomainname(); #endif #if defined (__stub__sleep) || defined (__stub____sleep) _sleep_will_always_fail_with_ENOSYS(); #else _sleep(); #endif #if defined (__stub_snprintf) || defined (__stub___snprintf) snprintf_will_always_fail_with_ENOSYS(); #else snprintf(); #endif #if defined (__stub_realpath) || defined (__stub___realpath) realpath_will_always_fail_with_ENOSYS(); #else realpath(); #endif #if defined (__stub_dlsym) || defined (__stub___dlsym) dlsym_will_always_fail_with_ENOSYS(); #else dlsym(); #endif #if defined (__stub_bzero) || defined (__stub___bzero) bzero_will_always_fail_with_ENOSYS(); #else bzero(); #endif #if defined (__stub__getcwd) || defined (__stub____getcwd) _getcwd_will_always_fail_with_ENOSYS(); #else _getcwd(); #endif #if defined (__stub_getwd) || defined (__stub___getwd) getwd_will_always_fail_with_ENOSYS(); #else getwd(); #endif #if defined (__stub_uname) || defined (__stub___uname) uname_will_always_fail_with_ENOSYS(); #else uname(); #endif #if defined (__stub__lseek) || defined (__stub____lseek) _lseek_will_always_fail_with_ENOSYS(); #else _lseek(); #endif #if defined (__stub_sleep) || defined (__stub___sleep) sleep_will_always_fail_with_ENOSYS(); #else sleep(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 8 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 8 unresolved externalsChecking for functions [rand getdomainname _sleep snprintf realpath dlsym] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char rand(); char getdomainname(); char _sleep(); char snprintf(); char realpath(); char dlsym(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_rand) || defined (__stub___rand) rand_will_always_fail_with_ENOSYS(); #else rand(); #endif #if defined (__stub_getdomainname) || defined (__stub___getdomainname) getdomainname_will_always_fail_with_ENOSYS(); #else getdomainname(); #endif #if defined (__stub__sleep) || defined (__stub____sleep) _sleep_will_always_fail_with_ENOSYS(); #else _sleep(); #endif #if defined (__stub_snprintf) || defined (__stub___snprintf) snprintf_will_always_fail_with_ENOSYS(); #else snprintf(); #endif #if defined (__stub_realpath) || defined (__stub___realpath) realpath_will_always_fail_with_ENOSYS(); #else realpath(); #endif #if defined (__stub_dlsym) || defined (__stub___dlsym) dlsym_will_always_fail_with_ENOSYS(); #else dlsym(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 4 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 4 unresolved externalsChecking for functions [rand getdomainname _sleep] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char rand(); char getdomainname(); char _sleep(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_rand) || defined (__stub___rand) rand_will_always_fail_with_ENOSYS(); #else rand(); #endif #if defined (__stub_getdomainname) || defined (__stub___getdomainname) getdomainname_will_always_fail_with_ENOSYS(); #else getdomainname(); #endif #if defined (__stub__sleep) || defined (__stub____sleep) _sleep_will_always_fail_with_ENOSYS(); #else _sleep(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [rand] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char rand(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_rand) || defined (__stub___rand) rand_will_always_fail_with_ENOSYS(); #else rand(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE_RAND" to "1" Checking for functions [getdomainname] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getdomainname(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getdomainname) || defined (__stub___getdomainname) getdomainname_will_always_fail_with_ENOSYS(); #else getdomainname(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getdomainname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [_sleep] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _sleep(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__sleep) || defined (__stub____sleep) _sleep_will_always_fail_with_ENOSYS(); #else _sleep(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE__SLEEP" to "1" Checking for functions [snprintf realpath dlsym] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char snprintf(); char realpath(); char dlsym(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_snprintf) || defined (__stub___snprintf) snprintf_will_always_fail_with_ENOSYS(); #else snprintf(); #endif #if defined (__stub_realpath) || defined (__stub___realpath) realpath_will_always_fail_with_ENOSYS(); #else realpath(); #endif #if defined (__stub_dlsym) || defined (__stub___dlsym) dlsym_will_always_fail_with_ENOSYS(); #else dlsym(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externalsChecking for functions [snprintf] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char snprintf(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_snprintf) || defined (__stub___snprintf) snprintf_will_always_fail_with_ENOSYS(); #else snprintf(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol snprintf referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [realpath] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char realpath(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_realpath) || defined (__stub___realpath) realpath_will_always_fail_with_ENOSYS(); #else realpath(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol realpath referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [dlsym] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char dlsym(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_dlsym) || defined (__stub___dlsym) dlsym_will_always_fail_with_ENOSYS(); #else dlsym(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol dlsym referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [bzero _getcwd getwd uname _lseek sleep] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char bzero(); char _getcwd(); char getwd(); char uname(); char _lseek(); char sleep(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_bzero) || defined (__stub___bzero) bzero_will_always_fail_with_ENOSYS(); #else bzero(); #endif #if defined (__stub__getcwd) || defined (__stub____getcwd) _getcwd_will_always_fail_with_ENOSYS(); #else _getcwd(); #endif #if defined (__stub_getwd) || defined (__stub___getwd) getwd_will_always_fail_with_ENOSYS(); #else getwd(); #endif #if defined (__stub_uname) || defined (__stub___uname) uname_will_always_fail_with_ENOSYS(); #else uname(); #endif #if defined (__stub__lseek) || defined (__stub____lseek) _lseek_will_always_fail_with_ENOSYS(); #else _lseek(); #endif #if defined (__stub_sleep) || defined (__stub___sleep) sleep_will_always_fail_with_ENOSYS(); #else sleep(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 4 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 4 unresolved externalsChecking for functions [bzero _getcwd getwd] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char bzero(); char _getcwd(); char getwd(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_bzero) || defined (__stub___bzero) bzero_will_always_fail_with_ENOSYS(); #else bzero(); #endif #if defined (__stub__getcwd) || defined (__stub____getcwd) _getcwd_will_always_fail_with_ENOSYS(); #else _getcwd(); #endif #if defined (__stub_getwd) || defined (__stub___getwd) getwd_will_always_fail_with_ENOSYS(); #else getwd(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externalsChecking for functions [bzero] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char bzero(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_bzero) || defined (__stub___bzero) bzero_will_always_fail_with_ENOSYS(); #else bzero(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol bzero referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [_getcwd] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _getcwd(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__getcwd) || defined (__stub____getcwd) _getcwd_will_always_fail_with_ENOSYS(); #else _getcwd(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE__GETCWD" to "1" Checking for functions [getwd] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getwd(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getwd) || defined (__stub___getwd) getwd_will_always_fail_with_ENOSYS(); #else getwd(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getwd referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [uname _lseek sleep] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char uname(); char _lseek(); char sleep(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_uname) || defined (__stub___uname) uname_will_always_fail_with_ENOSYS(); #else uname(); #endif #if defined (__stub__lseek) || defined (__stub____lseek) _lseek_will_always_fail_with_ENOSYS(); #else _lseek(); #endif #if defined (__stub_sleep) || defined (__stub___sleep) sleep_will_always_fail_with_ENOSYS(); #else sleep(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externalsChecking for functions [uname] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char uname(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_uname) || defined (__stub___uname) uname_will_always_fail_with_ENOSYS(); #else uname(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol uname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [_lseek] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _lseek(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__lseek) || defined (__stub____lseek) _lseek_will_always_fail_with_ENOSYS(); #else _lseek(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE__LSEEK" to "1" Checking for functions [sleep] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char sleep(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_sleep) || defined (__stub___sleep) sleep_will_always_fail_with_ENOSYS(); #else sleep(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol sleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [_access lseek usleep dlclose gethostname clock get_nprocs access _snprintf dlerror mkstemp fork] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _access(); char lseek(); char usleep(); char dlclose(); char gethostname(); char clock(); char get_nprocs(); char access(); char _snprintf(); char dlerror(); char mkstemp(); char fork(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__access) || defined (__stub____access) _access_will_always_fail_with_ENOSYS(); #else _access(); #endif #if defined (__stub_lseek) || defined (__stub___lseek) lseek_will_always_fail_with_ENOSYS(); #else lseek(); #endif #if defined (__stub_usleep) || defined (__stub___usleep) usleep_will_always_fail_with_ENOSYS(); #else usleep(); #endif #if defined (__stub_dlclose) || defined (__stub___dlclose) dlclose_will_always_fail_with_ENOSYS(); #else dlclose(); #endif #if defined (__stub_gethostname) || defined (__stub___gethostname) gethostname_will_always_fail_with_ENOSYS(); #else gethostname(); #endif #if defined (__stub_clock) || defined (__stub___clock) clock_will_always_fail_with_ENOSYS(); #else clock(); #endif #if defined (__stub_get_nprocs) || defined (__stub___get_nprocs) get_nprocs_will_always_fail_with_ENOSYS(); #else get_nprocs(); #endif #if defined (__stub_access) || defined (__stub___access) access_will_always_fail_with_ENOSYS(); #else access(); #endif #if defined (__stub__snprintf) || defined (__stub____snprintf) _snprintf_will_always_fail_with_ENOSYS(); #else _snprintf(); #endif #if defined (__stub_dlerror) || defined (__stub___dlerror) dlerror_will_always_fail_with_ENOSYS(); #else dlerror(); #endif #if defined (__stub_mkstemp) || defined (__stub___mkstemp) mkstemp_will_always_fail_with_ENOSYS(); #else mkstemp(); #endif #if defined (__stub_fork) || defined (__stub___fork) fork_will_always_fail_with_ENOSYS(); #else fork(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 8 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 8 unresolved externalsChecking for functions [_access lseek usleep dlclose gethostname clock] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _access(); char lseek(); char usleep(); char dlclose(); char gethostname(); char clock(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__access) || defined (__stub____access) _access_will_always_fail_with_ENOSYS(); #else _access(); #endif #if defined (__stub_lseek) || defined (__stub___lseek) lseek_will_always_fail_with_ENOSYS(); #else lseek(); #endif #if defined (__stub_usleep) || defined (__stub___usleep) usleep_will_always_fail_with_ENOSYS(); #else usleep(); #endif #if defined (__stub_dlclose) || defined (__stub___dlclose) dlclose_will_always_fail_with_ENOSYS(); #else dlclose(); #endif #if defined (__stub_gethostname) || defined (__stub___gethostname) gethostname_will_always_fail_with_ENOSYS(); #else gethostname(); #endif #if defined (__stub_clock) || defined (__stub___clock) clock_will_always_fail_with_ENOSYS(); #else clock(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externalsChecking for functions [_access lseek usleep] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _access(); char lseek(); char usleep(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__access) || defined (__stub____access) _access_will_always_fail_with_ENOSYS(); #else _access(); #endif #if defined (__stub_lseek) || defined (__stub___lseek) lseek_will_always_fail_with_ENOSYS(); #else lseek(); #endif #if defined (__stub_usleep) || defined (__stub___usleep) usleep_will_always_fail_with_ENOSYS(); #else usleep(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [_access] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _access(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__access) || defined (__stub____access) _access_will_always_fail_with_ENOSYS(); #else _access(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE__ACCESS" to "1" Checking for functions [lseek] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char lseek(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_lseek) || defined (__stub___lseek) lseek_will_always_fail_with_ENOSYS(); #else lseek(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE_LSEEK" to "1" Checking for functions [usleep] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char usleep(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_usleep) || defined (__stub___usleep) usleep_will_always_fail_with_ENOSYS(); #else usleep(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol usleep referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [dlclose gethostname clock] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char dlclose(); char gethostname(); char clock(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_dlclose) || defined (__stub___dlclose) dlclose_will_always_fail_with_ENOSYS(); #else dlclose(); #endif #if defined (__stub_gethostname) || defined (__stub___gethostname) gethostname_will_always_fail_with_ENOSYS(); #else gethostname(); #endif #if defined (__stub_clock) || defined (__stub___clock) clock_will_always_fail_with_ENOSYS(); #else clock(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externalsChecking for functions [dlclose] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char dlclose(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_dlclose) || defined (__stub___dlclose) dlclose_will_always_fail_with_ENOSYS(); #else dlclose(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol dlclose referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [gethostname] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char gethostname(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_gethostname) || defined (__stub___gethostname) gethostname_will_always_fail_with_ENOSYS(); #else gethostname(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol gethostname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [clock] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char clock(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_clock) || defined (__stub___clock) clock_will_always_fail_with_ENOSYS(); #else clock(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE_CLOCK" to "1" Checking for functions [get_nprocs access _snprintf dlerror mkstemp fork] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char get_nprocs(); char access(); char _snprintf(); char dlerror(); char mkstemp(); char fork(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_get_nprocs) || defined (__stub___get_nprocs) get_nprocs_will_always_fail_with_ENOSYS(); #else get_nprocs(); #endif #if defined (__stub_access) || defined (__stub___access) access_will_always_fail_with_ENOSYS(); #else access(); #endif #if defined (__stub__snprintf) || defined (__stub____snprintf) _snprintf_will_always_fail_with_ENOSYS(); #else _snprintf(); #endif #if defined (__stub_dlerror) || defined (__stub___dlerror) dlerror_will_always_fail_with_ENOSYS(); #else dlerror(); #endif #if defined (__stub_mkstemp) || defined (__stub___mkstemp) mkstemp_will_always_fail_with_ENOSYS(); #else mkstemp(); #endif #if defined (__stub_fork) || defined (__stub___fork) fork_will_always_fail_with_ENOSYS(); #else fork(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 5 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 5 unresolved externalsChecking for functions [get_nprocs access _snprintf] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char get_nprocs(); char access(); char _snprintf(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_get_nprocs) || defined (__stub___get_nprocs) get_nprocs_will_always_fail_with_ENOSYS(); #else get_nprocs(); #endif #if defined (__stub_access) || defined (__stub___access) access_will_always_fail_with_ENOSYS(); #else access(); #endif #if defined (__stub__snprintf) || defined (__stub____snprintf) _snprintf_will_always_fail_with_ENOSYS(); #else _snprintf(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externalsChecking for functions [get_nprocs] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char get_nprocs(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_get_nprocs) || defined (__stub___get_nprocs) get_nprocs_will_always_fail_with_ENOSYS(); #else get_nprocs(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol get_nprocs referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [access] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char access(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_access) || defined (__stub___access) access_will_always_fail_with_ENOSYS(); #else access(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE_ACCESS" to "1" Checking for functions [_snprintf] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _snprintf(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__snprintf) || defined (__stub____snprintf) _snprintf_will_always_fail_with_ENOSYS(); #else _snprintf(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol _snprintf referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [dlerror mkstemp fork] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char dlerror(); char mkstemp(); char fork(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_dlerror) || defined (__stub___dlerror) dlerror_will_always_fail_with_ENOSYS(); #else dlerror(); #endif #if defined (__stub_mkstemp) || defined (__stub___mkstemp) mkstemp_will_always_fail_with_ENOSYS(); #else mkstemp(); #endif #if defined (__stub_fork) || defined (__stub___fork) fork_will_always_fail_with_ENOSYS(); #else fork(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externalsChecking for functions [dlerror] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char dlerror(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_dlerror) || defined (__stub___dlerror) dlerror_will_always_fail_with_ENOSYS(); #else dlerror(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol dlerror referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [mkstemp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char mkstemp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_mkstemp) || defined (__stub___mkstemp) mkstemp_will_always_fail_with_ENOSYS(); #else mkstemp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol mkstemp referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [fork] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char fork(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_fork) || defined (__stub___fork) fork_will_always_fail_with_ENOSYS(); #else fork(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol fork referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [getpagesize sbreak memalign sigset getcwd gethostbyname gettimeofday readlink _set_output_format PXFGETARG sigaction strcasecmp dlopen drand48 socket memmove signal popen getrusage times _mkdir time sysctlbyname stricmp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getpagesize(); char sbreak(); char memalign(); char sigset(); char getcwd(); char gethostbyname(); char gettimeofday(); char readlink(); char _set_output_format(); char PXFGETARG(); char sigaction(); char strcasecmp(); char dlopen(); char drand48(); char socket(); char memmove(); char signal(); char popen(); char getrusage(); char times(); char _mkdir(); char time(); char sysctlbyname(); char stricmp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getpagesize) || defined (__stub___getpagesize) getpagesize_will_always_fail_with_ENOSYS(); #else getpagesize(); #endif #if defined (__stub_sbreak) || defined (__stub___sbreak) sbreak_will_always_fail_with_ENOSYS(); #else sbreak(); #endif #if defined (__stub_memalign) || defined (__stub___memalign) memalign_will_always_fail_with_ENOSYS(); #else memalign(); #endif #if defined (__stub_sigset) || defined (__stub___sigset) sigset_will_always_fail_with_ENOSYS(); #else sigset(); #endif #if defined (__stub_getcwd) || defined (__stub___getcwd) getcwd_will_always_fail_with_ENOSYS(); #else getcwd(); #endif #if defined (__stub_gethostbyname) || defined (__stub___gethostbyname) gethostbyname_will_always_fail_with_ENOSYS(); #else gethostbyname(); #endif #if defined (__stub_gettimeofday) || defined (__stub___gettimeofday) gettimeofday_will_always_fail_with_ENOSYS(); #else gettimeofday(); #endif #if defined (__stub_readlink) || defined (__stub___readlink) readlink_will_always_fail_with_ENOSYS(); #else readlink(); #endif #if defined (__stub__set_output_format) || defined (__stub____set_output_format) _set_output_format_will_always_fail_with_ENOSYS(); #else _set_output_format(); #endif #if defined (__stub_PXFGETARG) || defined (__stub___PXFGETARG) PXFGETARG_will_always_fail_with_ENOSYS(); #else PXFGETARG(); #endif #if defined (__stub_sigaction) || defined (__stub___sigaction) sigaction_will_always_fail_with_ENOSYS(); #else sigaction(); #endif #if defined (__stub_strcasecmp) || defined (__stub___strcasecmp) strcasecmp_will_always_fail_with_ENOSYS(); #else strcasecmp(); #endif #if defined (__stub_dlopen) || defined (__stub___dlopen) dlopen_will_always_fail_with_ENOSYS(); #else dlopen(); #endif #if defined (__stub_drand48) || defined (__stub___drand48) drand48_will_always_fail_with_ENOSYS(); #else drand48(); #endif #if defined (__stub_socket) || defined (__stub___socket) socket_will_always_fail_with_ENOSYS(); #else socket(); #endif #if defined (__stub_memmove) || defined (__stub___memmove) memmove_will_always_fail_with_ENOSYS(); #else memmove(); #endif #if defined (__stub_signal) || defined (__stub___signal) signal_will_always_fail_with_ENOSYS(); #else signal(); #endif #if defined (__stub_popen) || defined (__stub___popen) popen_will_always_fail_with_ENOSYS(); #else popen(); #endif #if defined (__stub_getrusage) || defined (__stub___getrusage) getrusage_will_always_fail_with_ENOSYS(); #else getrusage(); #endif #if defined (__stub_times) || defined (__stub___times) times_will_always_fail_with_ENOSYS(); #else times(); #endif #if defined (__stub__mkdir) || defined (__stub____mkdir) _mkdir_will_always_fail_with_ENOSYS(); #else _mkdir(); #endif #if defined (__stub_time) || defined (__stub___time) time_will_always_fail_with_ENOSYS(); #else time(); #endif #if defined (__stub_sysctlbyname) || defined (__stub___sysctlbyname) sysctlbyname_will_always_fail_with_ENOSYS(); #else sysctlbyname(); #endif #if defined (__stub_stricmp) || defined (__stub___stricmp) stricmp_will_always_fail_with_ENOSYS(); #else stricmp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main conftest.obj : error LNK2019: unresolved external symbol times referenced in function main conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 18 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main conftest.obj : error LNK2019: unresolved external symbol times referenced in function main conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 18 unresolved externalsChecking for functions [getpagesize sbreak memalign sigset getcwd gethostbyname gettimeofday readlink _set_output_format PXFGETARG sigaction strcasecmp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getpagesize(); char sbreak(); char memalign(); char sigset(); char getcwd(); char gethostbyname(); char gettimeofday(); char readlink(); char _set_output_format(); char PXFGETARG(); char sigaction(); char strcasecmp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getpagesize) || defined (__stub___getpagesize) getpagesize_will_always_fail_with_ENOSYS(); #else getpagesize(); #endif #if defined (__stub_sbreak) || defined (__stub___sbreak) sbreak_will_always_fail_with_ENOSYS(); #else sbreak(); #endif #if defined (__stub_memalign) || defined (__stub___memalign) memalign_will_always_fail_with_ENOSYS(); #else memalign(); #endif #if defined (__stub_sigset) || defined (__stub___sigset) sigset_will_always_fail_with_ENOSYS(); #else sigset(); #endif #if defined (__stub_getcwd) || defined (__stub___getcwd) getcwd_will_always_fail_with_ENOSYS(); #else getcwd(); #endif #if defined (__stub_gethostbyname) || defined (__stub___gethostbyname) gethostbyname_will_always_fail_with_ENOSYS(); #else gethostbyname(); #endif #if defined (__stub_gettimeofday) || defined (__stub___gettimeofday) gettimeofday_will_always_fail_with_ENOSYS(); #else gettimeofday(); #endif #if defined (__stub_readlink) || defined (__stub___readlink) readlink_will_always_fail_with_ENOSYS(); #else readlink(); #endif #if defined (__stub__set_output_format) || defined (__stub____set_output_format) _set_output_format_will_always_fail_with_ENOSYS(); #else _set_output_format(); #endif #if defined (__stub_PXFGETARG) || defined (__stub___PXFGETARG) PXFGETARG_will_always_fail_with_ENOSYS(); #else PXFGETARG(); #endif #if defined (__stub_sigaction) || defined (__stub___sigaction) sigaction_will_always_fail_with_ENOSYS(); #else sigaction(); #endif #if defined (__stub_strcasecmp) || defined (__stub___strcasecmp) strcasecmp_will_always_fail_with_ENOSYS(); #else strcasecmp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 11 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 11 unresolved externalsChecking for functions [getpagesize sbreak memalign sigset getcwd gethostbyname] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getpagesize(); char sbreak(); char memalign(); char sigset(); char getcwd(); char gethostbyname(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getpagesize) || defined (__stub___getpagesize) getpagesize_will_always_fail_with_ENOSYS(); #else getpagesize(); #endif #if defined (__stub_sbreak) || defined (__stub___sbreak) sbreak_will_always_fail_with_ENOSYS(); #else sbreak(); #endif #if defined (__stub_memalign) || defined (__stub___memalign) memalign_will_always_fail_with_ENOSYS(); #else memalign(); #endif #if defined (__stub_sigset) || defined (__stub___sigset) sigset_will_always_fail_with_ENOSYS(); #else sigset(); #endif #if defined (__stub_getcwd) || defined (__stub___getcwd) getcwd_will_always_fail_with_ENOSYS(); #else getcwd(); #endif #if defined (__stub_gethostbyname) || defined (__stub___gethostbyname) gethostbyname_will_always_fail_with_ENOSYS(); #else gethostbyname(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 5 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 5 unresolved externalsChecking for functions [getpagesize sbreak memalign] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getpagesize(); char sbreak(); char memalign(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getpagesize) || defined (__stub___getpagesize) getpagesize_will_always_fail_with_ENOSYS(); #else getpagesize(); #endif #if defined (__stub_sbreak) || defined (__stub___sbreak) sbreak_will_always_fail_with_ENOSYS(); #else sbreak(); #endif #if defined (__stub_memalign) || defined (__stub___memalign) memalign_will_always_fail_with_ENOSYS(); #else memalign(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externalsChecking for functions [getpagesize] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getpagesize(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getpagesize) || defined (__stub___getpagesize) getpagesize_will_always_fail_with_ENOSYS(); #else getpagesize(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getpagesize referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [sbreak] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char sbreak(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_sbreak) || defined (__stub___sbreak) sbreak_will_always_fail_with_ENOSYS(); #else sbreak(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol sbreak referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [memalign] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char memalign(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_memalign) || defined (__stub___memalign) memalign_will_always_fail_with_ENOSYS(); #else memalign(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol memalign referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [sigset getcwd gethostbyname] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char sigset(); char getcwd(); char gethostbyname(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_sigset) || defined (__stub___sigset) sigset_will_always_fail_with_ENOSYS(); #else sigset(); #endif #if defined (__stub_getcwd) || defined (__stub___getcwd) getcwd_will_always_fail_with_ENOSYS(); #else getcwd(); #endif #if defined (__stub_gethostbyname) || defined (__stub___gethostbyname) gethostbyname_will_always_fail_with_ENOSYS(); #else gethostbyname(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externalsChecking for functions [sigset] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char sigset(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_sigset) || defined (__stub___sigset) sigset_will_always_fail_with_ENOSYS(); #else sigset(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol sigset referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [getcwd] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getcwd(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getcwd) || defined (__stub___getcwd) getcwd_will_always_fail_with_ENOSYS(); #else getcwd(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE_GETCWD" to "1" Checking for functions [gethostbyname] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char gethostbyname(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_gethostbyname) || defined (__stub___gethostbyname) gethostbyname_will_always_fail_with_ENOSYS(); #else gethostbyname(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol gethostbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [gettimeofday readlink _set_output_format PXFGETARG sigaction strcasecmp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char gettimeofday(); char readlink(); char _set_output_format(); char PXFGETARG(); char sigaction(); char strcasecmp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_gettimeofday) || defined (__stub___gettimeofday) gettimeofday_will_always_fail_with_ENOSYS(); #else gettimeofday(); #endif #if defined (__stub_readlink) || defined (__stub___readlink) readlink_will_always_fail_with_ENOSYS(); #else readlink(); #endif #if defined (__stub__set_output_format) || defined (__stub____set_output_format) _set_output_format_will_always_fail_with_ENOSYS(); #else _set_output_format(); #endif #if defined (__stub_PXFGETARG) || defined (__stub___PXFGETARG) PXFGETARG_will_always_fail_with_ENOSYS(); #else PXFGETARG(); #endif #if defined (__stub_sigaction) || defined (__stub___sigaction) sigaction_will_always_fail_with_ENOSYS(); #else sigaction(); #endif #if defined (__stub_strcasecmp) || defined (__stub___strcasecmp) strcasecmp_will_always_fail_with_ENOSYS(); #else strcasecmp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 6 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 6 unresolved externalsChecking for functions [gettimeofday readlink _set_output_format] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char gettimeofday(); char readlink(); char _set_output_format(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_gettimeofday) || defined (__stub___gettimeofday) gettimeofday_will_always_fail_with_ENOSYS(); #else gettimeofday(); #endif #if defined (__stub_readlink) || defined (__stub___readlink) readlink_will_always_fail_with_ENOSYS(); #else readlink(); #endif #if defined (__stub__set_output_format) || defined (__stub____set_output_format) _set_output_format_will_always_fail_with_ENOSYS(); #else _set_output_format(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externalsChecking for functions [gettimeofday] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char gettimeofday(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_gettimeofday) || defined (__stub___gettimeofday) gettimeofday_will_always_fail_with_ENOSYS(); #else gettimeofday(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol gettimeofday referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [readlink] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char readlink(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_readlink) || defined (__stub___readlink) readlink_will_always_fail_with_ENOSYS(); #else readlink(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol readlink referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [_set_output_format] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _set_output_format(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__set_output_format) || defined (__stub____set_output_format) _set_output_format_will_always_fail_with_ENOSYS(); #else _set_output_format(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol _set_output_format referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [PXFGETARG sigaction strcasecmp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char PXFGETARG(); char sigaction(); char strcasecmp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_PXFGETARG) || defined (__stub___PXFGETARG) PXFGETARG_will_always_fail_with_ENOSYS(); #else PXFGETARG(); #endif #if defined (__stub_sigaction) || defined (__stub___sigaction) sigaction_will_always_fail_with_ENOSYS(); #else sigaction(); #endif #if defined (__stub_strcasecmp) || defined (__stub___strcasecmp) strcasecmp_will_always_fail_with_ENOSYS(); #else strcasecmp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externalsChecking for functions [PXFGETARG] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char PXFGETARG(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_PXFGETARG) || defined (__stub___PXFGETARG) PXFGETARG_will_always_fail_with_ENOSYS(); #else PXFGETARG(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [sigaction] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char sigaction(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_sigaction) || defined (__stub___sigaction) sigaction_will_always_fail_with_ENOSYS(); #else sigaction(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol sigaction referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [strcasecmp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char strcasecmp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_strcasecmp) || defined (__stub___strcasecmp) strcasecmp_will_always_fail_with_ENOSYS(); #else strcasecmp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol strcasecmp referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [dlopen drand48 socket memmove signal popen getrusage times _mkdir time sysctlbyname stricmp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char dlopen(); char drand48(); char socket(); char memmove(); char signal(); char popen(); char getrusage(); char times(); char _mkdir(); char time(); char sysctlbyname(); char stricmp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_dlopen) || defined (__stub___dlopen) dlopen_will_always_fail_with_ENOSYS(); #else dlopen(); #endif #if defined (__stub_drand48) || defined (__stub___drand48) drand48_will_always_fail_with_ENOSYS(); #else drand48(); #endif #if defined (__stub_socket) || defined (__stub___socket) socket_will_always_fail_with_ENOSYS(); #else socket(); #endif #if defined (__stub_memmove) || defined (__stub___memmove) memmove_will_always_fail_with_ENOSYS(); #else memmove(); #endif #if defined (__stub_signal) || defined (__stub___signal) signal_will_always_fail_with_ENOSYS(); #else signal(); #endif #if defined (__stub_popen) || defined (__stub___popen) popen_will_always_fail_with_ENOSYS(); #else popen(); #endif #if defined (__stub_getrusage) || defined (__stub___getrusage) getrusage_will_always_fail_with_ENOSYS(); #else getrusage(); #endif #if defined (__stub_times) || defined (__stub___times) times_will_always_fail_with_ENOSYS(); #else times(); #endif #if defined (__stub__mkdir) || defined (__stub____mkdir) _mkdir_will_always_fail_with_ENOSYS(); #else _mkdir(); #endif #if defined (__stub_time) || defined (__stub___time) time_will_always_fail_with_ENOSYS(); #else time(); #endif #if defined (__stub_sysctlbyname) || defined (__stub___sysctlbyname) sysctlbyname_will_always_fail_with_ENOSYS(); #else sysctlbyname(); #endif #if defined (__stub_stricmp) || defined (__stub___stricmp) stricmp_will_always_fail_with_ENOSYS(); #else stricmp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main conftest.obj : error LNK2019: unresolved external symbol times referenced in function main conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 7 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main conftest.obj : error LNK2019: unresolved external symbol times referenced in function main conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 7 unresolved externalsChecking for functions [dlopen drand48 socket memmove signal popen] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char dlopen(); char drand48(); char socket(); char memmove(); char signal(); char popen(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_dlopen) || defined (__stub___dlopen) dlopen_will_always_fail_with_ENOSYS(); #else dlopen(); #endif #if defined (__stub_drand48) || defined (__stub___drand48) drand48_will_always_fail_with_ENOSYS(); #else drand48(); #endif #if defined (__stub_socket) || defined (__stub___socket) socket_will_always_fail_with_ENOSYS(); #else socket(); #endif #if defined (__stub_memmove) || defined (__stub___memmove) memmove_will_always_fail_with_ENOSYS(); #else memmove(); #endif #if defined (__stub_signal) || defined (__stub___signal) signal_will_always_fail_with_ENOSYS(); #else signal(); #endif #if defined (__stub_popen) || defined (__stub___popen) popen_will_always_fail_with_ENOSYS(); #else popen(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 4 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 4 unresolved externalsChecking for functions [dlopen drand48 socket] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char dlopen(); char drand48(); char socket(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_dlopen) || defined (__stub___dlopen) dlopen_will_always_fail_with_ENOSYS(); #else dlopen(); #endif #if defined (__stub_drand48) || defined (__stub___drand48) drand48_will_always_fail_with_ENOSYS(); #else drand48(); #endif #if defined (__stub_socket) || defined (__stub___socket) socket_will_always_fail_with_ENOSYS(); #else socket(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externalsChecking for functions [dlopen] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char dlopen(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_dlopen) || defined (__stub___dlopen) dlopen_will_always_fail_with_ENOSYS(); #else dlopen(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol dlopen referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [drand48] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char drand48(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_drand48) || defined (__stub___drand48) drand48_will_always_fail_with_ENOSYS(); #else drand48(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol drand48 referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [socket] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char socket(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_socket) || defined (__stub___socket) socket_will_always_fail_with_ENOSYS(); #else socket(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol socket referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [memmove signal popen] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char memmove(); char signal(); char popen(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_memmove) || defined (__stub___memmove) memmove_will_always_fail_with_ENOSYS(); #else memmove(); #endif #if defined (__stub_signal) || defined (__stub___signal) signal_will_always_fail_with_ENOSYS(); #else signal(); #endif #if defined (__stub_popen) || defined (__stub___popen) popen_will_always_fail_with_ENOSYS(); #else popen(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [memmove] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char memmove(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_memmove) || defined (__stub___memmove) memmove_will_always_fail_with_ENOSYS(); #else memmove(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE_MEMMOVE" to "1" Checking for functions [signal] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char signal(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_signal) || defined (__stub___signal) signal_will_always_fail_with_ENOSYS(); #else signal(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE_SIGNAL" to "1" Checking for functions [popen] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char popen(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_popen) || defined (__stub___popen) popen_will_always_fail_with_ENOSYS(); #else popen(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol popen referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [getrusage times _mkdir time sysctlbyname stricmp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getrusage(); char times(); char _mkdir(); char time(); char sysctlbyname(); char stricmp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getrusage) || defined (__stub___getrusage) getrusage_will_always_fail_with_ENOSYS(); #else getrusage(); #endif #if defined (__stub_times) || defined (__stub___times) times_will_always_fail_with_ENOSYS(); #else times(); #endif #if defined (__stub__mkdir) || defined (__stub____mkdir) _mkdir_will_always_fail_with_ENOSYS(); #else _mkdir(); #endif #if defined (__stub_time) || defined (__stub___time) time_will_always_fail_with_ENOSYS(); #else time(); #endif #if defined (__stub_sysctlbyname) || defined (__stub___sysctlbyname) sysctlbyname_will_always_fail_with_ENOSYS(); #else sysctlbyname(); #endif #if defined (__stub_stricmp) || defined (__stub___stricmp) stricmp_will_always_fail_with_ENOSYS(); #else stricmp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main conftest.obj : error LNK2019: unresolved external symbol times referenced in function main conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main conftest.obj : error LNK2019: unresolved external symbol times referenced in function main conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 3 unresolved externalsChecking for functions [getrusage times _mkdir] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getrusage(); char times(); char _mkdir(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getrusage) || defined (__stub___getrusage) getrusage_will_always_fail_with_ENOSYS(); #else getrusage(); #endif #if defined (__stub_times) || defined (__stub___times) times_will_always_fail_with_ENOSYS(); #else times(); #endif #if defined (__stub__mkdir) || defined (__stub____mkdir) _mkdir_will_always_fail_with_ENOSYS(); #else _mkdir(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main conftest.obj : error LNK2019: unresolved external symbol times referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main conftest.obj : error LNK2019: unresolved external symbol times referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 2 unresolved externalsChecking for functions [getrusage] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char getrusage(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_getrusage) || defined (__stub___getrusage) getrusage_will_always_fail_with_ENOSYS(); #else getrusage(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol getrusage referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [times] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char times(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_times) || defined (__stub___times) times_will_always_fail_with_ENOSYS(); #else times(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol times referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol times referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [_mkdir] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _mkdir(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__mkdir) || defined (__stub____mkdir) _mkdir_will_always_fail_with_ENOSYS(); #else _mkdir(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE__MKDIR" to "1" Checking for functions [time sysctlbyname stricmp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char time(); char sysctlbyname(); char stricmp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_time) || defined (__stub___time) time_will_always_fail_with_ENOSYS(); #else time(); #endif #if defined (__stub_sysctlbyname) || defined (__stub___sysctlbyname) sysctlbyname_will_always_fail_with_ENOSYS(); #else sysctlbyname(); #endif #if defined (__stub_stricmp) || defined (__stub___stricmp) stricmp_will_always_fail_with_ENOSYS(); #else stricmp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [time] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char time(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_time) || defined (__stub___time) time_will_always_fail_with_ENOSYS(); #else time(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE_TIME" to "1" Checking for functions [sysctlbyname] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char sysctlbyname(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_sysctlbyname) || defined (__stub___sysctlbyname) sysctlbyname_will_always_fail_with_ENOSYS(); #else sysctlbyname(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol sysctlbyname referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [stricmp] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char stricmp(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_stricmp) || defined (__stub___stricmp) stricmp_will_always_fail_with_ENOSYS(); #else stricmp(); #endif ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o Defined "HAVE_STRICMP" to "1" ================================================================================ TEST configureMemorySize from config.utilities.getResidentSetSize(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/getResidentSetSize.py:31) TESTING: configureMemorySize from config.utilities.getResidentSetSize(config/BuildSystem/config/utilities/getResidentSetSize.py:31) Try to determine how to measure the memory usage Defined "USE_PROC_FOR_SIZE" to "1" Using /proc for PetscMemoryGetCurrentUsage() ================================================================================ TEST configureFortranCommandLine from config.utilities.fortranCommandLine(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/fortranCommandLine.py:27) TESTING: configureFortranCommandLine from config.utilities.fortranCommandLine(config/BuildSystem/config/utilities/fortranCommandLine.py:27) Check for the mechanism to retrieve command line arguments in Fortran Defined "HAVE_FORTRAN_GET_COMMAND_ARGUMENT" to "1" Pushing language FC Checking for functions [] in library [''] [] Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.F90 Successful compile: Source: program main integer i character*(80) arg i = command_argument_count() call get_command_argument(i,arg) end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o Popping language FC Popping language FC Pushing language C Popping language C Checking for functions [GET_COMMAND_ARGUMENT] in library [''] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char GET_COMMAND_ARGUMENT(); static void _check_GET_COMMAND_ARGUMENT() { GET_COMMAND_ARGUMENT(); } int main() { _check_GET_COMMAND_ARGUMENT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol GET_COMMAND_ARGUMENT referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol GET_COMMAND_ARGUMENT referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C Checking for functions [GETARG] in library [''] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char GETARG(); static void _check_GETARG() { GETARG(); } int main() { _check_GETARG();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol GETARG referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol GETARG referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C Pushing language C Popping language C Pushing language C Popping language C Pushing language C Popping language C Pushing language C Popping language C Pushing language C Popping language C Checking for functions [ipxfargc_] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char ipxfargc_(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_ipxfargc_) || defined (__stub___ipxfargc_) ipxfargc__will_always_fail_with_ENOSYS(); #else ipxfargc_(); #endif ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol ipxfargc_ referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol ipxfargc_ referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [f90_unix_MP_iargc] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char f90_unix_MP_iargc(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_f90_unix_MP_iargc) || defined (__stub___f90_unix_MP_iargc) f90_unix_MP_iargc_will_always_fail_with_ENOSYS(); #else f90_unix_MP_iargc(); #endif ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol f90_unix_MP_iargc referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol f90_unix_MP_iargc referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [PXFGETARG] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char PXFGETARG(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_PXFGETARG) || defined (__stub___PXFGETARG) PXFGETARG_will_always_fail_with_ENOSYS(); #else PXFGETARG(); #endif ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol PXFGETARG referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [iargc_] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char iargc_(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_iargc_) || defined (__stub___iargc_) iargc__will_always_fail_with_ENOSYS(); #else iargc_(); #endif ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol iargc_ referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol iargc_ referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externalsChecking for functions [GETARG at 16] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(13): error: unrecognized token char GETARG at 16(); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(13): error: expected a ";" char GETARG at 16(); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(21): error: unrecognized token #if defined (__stub_GETARG at 16) || defined (__stub___GETARG at 16) ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(21): error: expected a ")" #if defined (__stub_GETARG at 16) || defined (__stub___GETARG at 16) ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(24): error: unrecognized token GETARG at 16(); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(24): error: expected a ";" GETARG at 16(); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(13): error: unrecognized token char GETARG at 16(); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(13): error: expected a ";" char GETARG at 16(); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(21): error: unrecognized token #if defined (__stub_GETARG at 16) || defined (__stub___GETARG at 16) ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(21): error: expected a ")" #if defined (__stub_GETARG at 16) || defined (__stub___GETARG at 16) ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(24): error: unrecognized token GETARG at 16(); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c(24): error: expected a ";" GETARG at 16(); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char GETARG at 16(); #ifdef __cplusplus } #endif int main() { #if defined (__stub_GETARG at 16) || defined (__stub___GETARG at 16) GETARG at 16_will_always_fail_with_ENOSYS(); #else GETARG at 16(); #endif ; return 0; } Compile failed inside link Checking for functions [_gfortran_iargc] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* System header to define __stub macros and hopefully no other prototypes since they would conflict with our 'char funcname()' declaration below. */ #include /* Override any gcc2 internal prototype to avoid an error. */ #ifdef __cplusplus extern "C" { #endif /* We use char because int might match the return type of a gcc2 builtin and then its argument prototype would still apply. */ char _gfortran_iargc(); #ifdef __cplusplus } #endif int main() { #if defined (__stub__gfortran_iargc) || defined (__stub____gfortran_iargc) _gfortran_iargc_will_always_fail_with_ENOSYS(); #else _gfortran_iargc(); #endif ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions/conftest.o stdout: conftest.obj : error LNK2019: unresolved external symbol _gfortran_iargc referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol _gfortran_iargc referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.functions\conftest.exe : fatal error LNK1120: 1 unresolved externals================================================================================ TEST configureFeatureTestMacros from config.utilities.featureTestMacros(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/featureTestMacros.py:13) TESTING: configureFeatureTestMacros from config.utilities.featureTestMacros(config/BuildSystem/config/utilities/featureTestMacros.py:13) Checks if certain feature test macros are support All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.featureTestMacros\conftest.c(4): catastrophic error: cannot open source file "sysctl.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.featureTestMacros\conftest.c (code 4) Possible ERROR while running compiler: exit code 1024 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.featureTestMacros\conftest.c(4): catastrophic error: cannot open source file "sysctl.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.featureTestMacros\conftest.c (code 4)Source: #include "confdefs.h" #include "conffix.h" #define _POSIX_C_SOURCE 200112L #include int main() { ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #define _BSD_SOURCE #include int main() { ; return 0; } Defined "_BSD_SOURCE" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #define _DEFAULT_SOURCE #include int main() { ; return 0; } Defined "_DEFAULT_SOURCE" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.featureTestMacros\conftest.c(4): catastrophic error: cannot open source file "sched.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.featureTestMacros\conftest.c (code 4) Possible ERROR while running compiler: exit code 1024 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.featureTestMacros\conftest.c(4): catastrophic error: cannot open source file "sched.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.featureTestMacros\conftest.c (code 4)Source: #include "confdefs.h" #include "conffix.h" #define _GNU_SOURCE #include int main() { cpu_set_t mset; CPU_ZERO(&mset);; return 0; } ================================================================================ TEST configureMissingDefines from config.utilities.missing(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/missing.py:57) TESTING: configureMissingDefines from config.utilities.missing(config/BuildSystem/config/utilities/missing.py:57) Checks for limits All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #ifdef PETSC_HAVE_LIMITS_H #include #endif int main() { int i=INT_MAX; if (i); ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #ifdef PETSC_HAVE_FLOAT_H #include #endif int main() { double d=DBL_MAX; if (d); ; return 0; } ================================================================================ TEST configureMissingUtypeTypedefs from config.utilities.missing(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/missing.py:67) TESTING: configureMissingUtypeTypedefs from config.utilities.missing(config/BuildSystem/config/utilities/missing.py:67) Checks if u_short is undefined Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "u_short" is undefined u_short foo; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "u_short" is undefined u_short foo; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { u_short foo; ; return 0; } Defined "NEEDS_UTYPE_TYPEDEFS" to "1" ================================================================================ TEST configureMissingFunctions from config.utilities.missing(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/missing.py:73) TESTING: configureMissingFunctions from config.utilities.missing(config/BuildSystem/config/utilities/missing.py:73) Checks for SOCKETS Checking for functions [socket] in library ['Ws2_32.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ #include static void _check_socket() { socket(0,0,0);; } int main() { _check_socket();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o Ws2_32.lib Defined "HAVE_LIBWS2_32" to "1" Popping language C Adding ['Ws2_32.lib'] to LIBS Defined "HAVE_WINSOCK2_H" to "1" Defined "HAVE_SOCKET" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { closesocket(0); return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o Ws2_32.lib Defined "HAVE_CLOSESOCKET" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { WSAGetLastError(); return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o Ws2_32.lib Defined "HAVE_WSAGETLASTERROR" to "1" ================================================================================ TEST configureMissingSignals from config.utilities.missing(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/missing.py:93) TESTING: configureMissingSignals from config.utilities.missing(config/BuildSystem/config/utilities/missing.py:93) Check for missing signals, and define MISSING_ if necessary Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGABRT; if (i); ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGALRM" is undefined int i=SIGALRM; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGALRM" is undefined int i=SIGALRM; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGALRM; if (i); ; return 0; } Defined "MISSING_SIGALRM" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGBUS" is undefined int i=SIGBUS; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGBUS" is undefined int i=SIGBUS; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGBUS; if (i); ; return 0; } Defined "MISSING_SIGBUS" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGCHLD" is undefined int i=SIGCHLD; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGCHLD" is undefined int i=SIGCHLD; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGCHLD; if (i); ; return 0; } Defined "MISSING_SIGCHLD" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGCONT" is undefined int i=SIGCONT; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGCONT" is undefined int i=SIGCONT; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGCONT; if (i); ; return 0; } Defined "MISSING_SIGCONT" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGFPE; if (i); ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGHUP" is undefined int i=SIGHUP; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGHUP" is undefined int i=SIGHUP; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGHUP; if (i); ; return 0; } Defined "MISSING_SIGHUP" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGILL; if (i); ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGINT; if (i); ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGKILL" is undefined int i=SIGKILL; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGKILL" is undefined int i=SIGKILL; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGKILL; if (i); ; return 0; } Defined "MISSING_SIGKILL" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGPIPE" is undefined int i=SIGPIPE; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGPIPE" is undefined int i=SIGPIPE; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGPIPE; if (i); ; return 0; } Defined "MISSING_SIGPIPE" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGQUIT" is undefined int i=SIGQUIT; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGQUIT" is undefined int i=SIGQUIT; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGQUIT; if (i); ; return 0; } Defined "MISSING_SIGQUIT" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGSEGV; if (i); ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGSTOP" is undefined int i=SIGSTOP; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGSTOP" is undefined int i=SIGSTOP; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGSTOP; if (i); ; return 0; } Defined "MISSING_SIGSTOP" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGSYS" is undefined int i=SIGSYS; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGSYS" is undefined int i=SIGSYS; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGSYS; if (i); ; return 0; } Defined "MISSING_SIGSYS" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGTERM; if (i); ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGTRAP" is undefined int i=SIGTRAP; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGTRAP" is undefined int i=SIGTRAP; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGTRAP; if (i); ; return 0; } Defined "MISSING_SIGTRAP" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGTSTP" is undefined int i=SIGTSTP; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGTSTP" is undefined int i=SIGTSTP; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGTSTP; if (i); ; return 0; } Defined "MISSING_SIGTSTP" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGURG" is undefined int i=SIGURG; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGURG" is undefined int i=SIGURG; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGURG; if (i); ; return 0; } Defined "MISSING_SIGURG" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGUSR1" is undefined int i=SIGUSR1; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGUSR1" is undefined int i=SIGUSR1; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGUSR1; if (i); ; return 0; } Defined "MISSING_SIGUSR1" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGUSR2" is undefined int i=SIGUSR2; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(6): error: identifier "SIGUSR2" is undefined int i=SIGUSR2; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include int main() { int i=SIGUSR2; if (i); ; return 0; } Defined "MISSING_SIGUSR2" to "1" ================================================================================ TEST configureMissingGetdomainnamePrototype from config.utilities.missing(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/missing.py:110) TESTING: configureMissingGetdomainnamePrototype from config.utilities.missing(config/BuildSystem/config/utilities/missing.py:110) Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(21): error: identifier "getdomainname" is undefined int (*getdomainname_ptr)(char*,size_t) = getdomainname; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(21): error: identifier "getdomainname" is undefined int (*getdomainname_ptr)(char*,size_t) = getdomainname; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #if !defined(_BSD_SOURCE) #define _BSD_SOURCE #endif #if !defined(_DEFAULT_SOURCE) #define _DEFAULT_SOURCE #endif #ifdef PETSC_HAVE_UNISTD_H #include #endif #ifdef PETSC_HAVE_NETDB_H #include #endif int main() { int (*getdomainname_ptr)(char*,size_t) = getdomainname; char test[10]; if (getdomainname_ptr(test,10)) return 1; ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(21): error: identifier "getdomainname" is undefined int (*getdomainname_ptr)(char*,int) = getdomainname; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(21): error: identifier "getdomainname" is undefined int (*getdomainname_ptr)(char*,int) = getdomainname; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #if !defined(_BSD_SOURCE) #define _BSD_SOURCE #endif #if !defined(_DEFAULT_SOURCE) #define _DEFAULT_SOURCE #endif #ifdef PETSC_HAVE_UNISTD_H #include #endif #ifdef PETSC_HAVE_NETDB_H #include #endif int main() { int (*getdomainname_ptr)(char*,int) = getdomainname; char test[10]; if (getdomainname_ptr(test,10)) return 1; ; return 0; } Added prototype #include int getdomainname(char *, size_t); to language C Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.cc stdout: conftest.cc C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc(21): error: identifier "getdomainname" is undefined int (*getdomainname_ptr)(char*,size_t) = getdomainname; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.cc C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc(21): error: identifier "getdomainname" is undefined int (*getdomainname_ptr)(char*,size_t) = getdomainname; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc (code 2)Source: #include "confdefs.h" #include "conffix.h" #if !defined(_BSD_SOURCE) #define _BSD_SOURCE #endif #if !defined(_DEFAULT_SOURCE) #define _DEFAULT_SOURCE #endif #ifdef PETSC_HAVE_UNISTD_H #include #endif #ifdef PETSC_HAVE_NETDB_H #include #endif int main() { int (*getdomainname_ptr)(char*,size_t) = getdomainname; char test[10]; if (getdomainname_ptr(test,10)) return 1; ; return 0; } Compile failed inside link Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.cc stdout: conftest.cc C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc(21): error: identifier "getdomainname" is undefined int (*getdomainname_ptr)(char*,int) = getdomainname; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.cc C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc(21): error: identifier "getdomainname" is undefined int (*getdomainname_ptr)(char*,int) = getdomainname; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc (code 2)Source: #include "confdefs.h" #include "conffix.h" #if !defined(_BSD_SOURCE) #define _BSD_SOURCE #endif #if !defined(_DEFAULT_SOURCE) #define _DEFAULT_SOURCE #endif #ifdef PETSC_HAVE_UNISTD_H #include #endif #ifdef PETSC_HAVE_NETDB_H #include #endif int main() { int (*getdomainname_ptr)(char*,int) = getdomainname; char test[10]; if (getdomainname_ptr(test,10)) return 1; ; return 0; } Compile failed inside link Added prototype #include int getdomainname(char *, size_t); to language extern C Popping language Cxx ================================================================================ TEST configureMissingSrandPrototype from config.utilities.missing(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/missing.py:135) TESTING: configureMissingSrandPrototype from config.utilities.missing(config/BuildSystem/config/utilities/missing.py:135) Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(18): error: identifier "drand48" is undefined double (*drand48_ptr)(void) = drand48; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(19): error: identifier "srand48" is undefined void (*srand48_ptr)(long int) = srand48; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(18): error: identifier "drand48" is undefined double (*drand48_ptr)(void) = drand48; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c(19): error: identifier "srand48" is undefined void (*srand48_ptr)(long int) = srand48; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #if !defined(_BSD_SOURCE) #define _BSD_SOURCE #endif #if !defined(_DEFAULT_SOURCE) #define _DEFAULT_SOURCE #endif #ifdef PETSC_HAVE_STDLIB_H #include #endif int main() { double (*drand48_ptr)(void) = drand48; void (*srand48_ptr)(long int) = srand48; long int seed=10; srand48_ptr(seed); if (drand48_ptr() > 0.5) return 1; ; return 0; } Added prototype double drand48(void); to language C Added prototype void srand48(long int); to language C Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp -TP /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing/conftest.cc stdout: conftest.cc C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc(18): error: identifier "drand48" is undefined double (*drand48_ptr)(void) = drand48; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc(19): error: identifier "srand48" is undefined void (*srand48_ptr)(long int) = srand48; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.cc C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc(18): error: identifier "drand48" is undefined double (*drand48_ptr)(void) = drand48; ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc(19): error: identifier "srand48" is undefined void (*srand48_ptr)(long int) = srand48; ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.utilities.missing\conftest.cc (code 2)Source: #include "confdefs.h" #include "conffix.h" #if !defined(_BSD_SOURCE) #define _BSD_SOURCE #endif #if !defined(_DEFAULT_SOURCE) #define _DEFAULT_SOURCE #endif #ifdef PETSC_HAVE_STDLIB_H #include #endif int main() { double (*drand48_ptr)(void) = drand48; void (*srand48_ptr)(long int) = srand48; long int seed=10; srand48_ptr(seed); if (drand48_ptr() > 0.5) return 1; ; return 0; } Compile failed inside link Added prototype double drand48(void); to language extern C Added prototype void srand48(long int); to language extern C Popping language Cxx ================================================================================ TEST configureFPTrap from config.utilities.FPTrap(/home/alireza/petsc-3.9.3/config/BuildSystem/config/utilities/FPTrap.py:28) TESTING: configureFPTrap from config.utilities.FPTrap(config/BuildSystem/config/utilities/FPTrap.py:28) Checking the handling of floating point traps Checking for header: sigfpe.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sigfpe.h" #include ^ #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "sigfpe.h" #include ^ #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: Checking for header: fpxcp.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "fpxcp.h" #include ^ #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "fpxcp.h" #include ^ #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: Checking for header: floatingpoint.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "floatingpoint.h" #include ^ #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "floatingpoint.h" #include ^ #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST configureScalarType from PETSc.options.scalarTypes(/home/alireza/petsc-3.9.3/config/PETSc/options/scalarTypes.py:37) TESTING: configureScalarType from PETSc.options.scalarTypes(config/PETSc/options/scalarTypes.py:37) Choose between real and complex numbers Defined "USE_SCALAR_REAL" to "1" Scalar type is real Pushing language C All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { double b = 2.0; int a = isnormal(b); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.o Ws2_32.lib Defined "HAVE_ISNORMAL" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { double b = 2.0; int a = isnan(b); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.o Ws2_32.lib Defined "HAVE_ISNAN" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { double b = 2.0; int a = isinf(b); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.o Ws2_32.lib Defined "HAVE_ISINF" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { double b = 2.0;int a = _isnan(b); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.o Ws2_32.lib Defined "HAVE__ISNAN" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { double b = 2.0;int a = _finite(b); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes/conftest.o Ws2_32.lib Defined "HAVE__FINITE" to "1" Popping language C ================================================================================ TEST configurePrecision from PETSc.options.scalarTypes(/home/alireza/petsc-3.9.3/config/PETSc/options/scalarTypes.py:79) TESTING: configurePrecision from PETSc.options.scalarTypes(config/PETSc/options/scalarTypes.py:79) Set the default real number precision for PETSc objects Defined "USE_REAL_DOUBLE" to "1" Defined make macro "PETSC_SCALAR_SIZE" to "64" Precision is double ================================================================================ TEST configureMkdir from config.programs(/home/alireza/petsc-3.9.3/config/BuildSystem/config/programs.py:23) TESTING: configureMkdir from config.programs(config/BuildSystem/config/programs.py:23) Make sure we can have mkdir automatically make intermediate directories Checking for program /usr/bin/mkdir...found Executing: /usr/bin/mkdir -p .conftest/tmp Adding -p flag to /usr/bin/mkdir -p to automatically create directories Defined make macro "MKDIR" to "/usr/bin/mkdir -p" ================================================================================ TEST configureAutoreconf from config.programs(/home/alireza/petsc-3.9.3/config/BuildSystem/config/programs.py:45) TESTING: configureAutoreconf from config.programs(config/BuildSystem/config/programs.py:45) Check for autoreconf Checking for program /usr/bin/autoreconf...found All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.programs Executing: cd /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.programs/autoconfdir&&/usr/bin/autoreconf autoreconf test successful! Checking for program /usr/bin/libtoolize...found ================================================================================ TEST configurePrograms from config.programs(/home/alireza/petsc-3.9.3/config/BuildSystem/config/programs.py:72) TESTING: configurePrograms from config.programs(config/BuildSystem/config/programs.py:72) Check for the programs needed to build and run PETSc Checking for program /usr/bin/sh...found Defined make macro "SHELL" to "/usr/bin/sh" Checking for program /usr/bin/sed...found Defined make macro "SED" to "/usr/bin/sed" Executing: /usr/bin/sed -i s/sed/sd/g "/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.programs/sed1" Adding SEDINPLACE cmd: /usr/bin/sed -i Defined make macro "SEDINPLACE" to "/usr/bin/sed -i" Checking for program /usr/bin/mv...found Defined make macro "MV" to "/usr/bin/mv" Checking for program /usr/bin/cp...found Defined make macro "CP" to "/usr/bin/cp" Checking for program /usr/bin/grep...found Defined make macro "GREP" to "/usr/bin/grep" Checking for program /usr/bin/rm...found Defined make macro "RM" to "/usr/bin/rm -f" Checking for program /usr/bin/diff...found Executing: "/usr/bin/diff" -w "/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.programs/diff1" "/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.programs/diff2" Defined make macro "DIFF" to "/usr/bin/diff -w" Checking for program /usr/ucb/ps...not found Checking for program /usr/usb/ps...not found Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/ps...not found Checking for program /usr/bin/gzip...found Defined make macro "GZIP" to "/usr/bin/gzip" Defined "HAVE_GZIP" to "1" Defined make macro "PYTHON" to "/usr/bin/python" Checking for program /usr/bin/m4...found Defined make macro "M4" to "/usr/bin/m4" ================================================================================ TEST configureMake from config.packages.make(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/make.py:84) TESTING: configureMake from config.packages.make(config/BuildSystem/config/packages/make.py:84) Check for user specified make - or gmake, make Checking for program /usr/bin/make...found Defined make macro "MAKE" to "/usr/bin/make" Executing: /usr/bin/make --version stdout: GNU Make 4.2.1 Built for x86_64-unknown-cygwin Copyright (C) 1988-2016 Free Software Foundation, Inc. License GPLv3+: GNU GPL version 3 or later This is free software: you are free to change and redistribute it. There is NO WARRANTY, to the extent permitted by law. ================================================================================ TEST configureCheckGNUMake from config.packages.make(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/make.py:121) TESTING: configureCheckGNUMake from config.packages.make(config/BuildSystem/config/packages/make.py:121) Setup other GNU make stuff Executing: /usr/bin/make --version stdout: GNU Make 4.2.1 Built for x86_64-unknown-cygwin Copyright (C) 1988-2016 Free Software Foundation, Inc. License GPLv3+: GNU GPL version 3 or later This is free software: you are free to change and redistribute it. There is NO WARRANTY, to the extent permitted by law. Executing: uname -s stdout: CYGWIN_NT-6.1 Executing: uname -s stdout: CYGWIN_NT-6.1 Defined make macro "MAKE_IS_GNUMAKE" to "1" Defined make rule "libc" with dependencies "${LIBNAME}(${OBJSC})" and code [] Defined make rule "libcxx" with dependencies "${LIBNAME}(${OBJSCXX})" and code [] Defined make rule "libcu" with dependencies "${LIBNAME}(${OBJSCU})" and code [] Defined make rule "libf" with dependencies "${OBJSF}" and code -${AR} ${AR_FLAGS} ${LIBNAME} ${OBJSF} ================================================================================ TEST configureMakeNP from config.packages.make(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/make.py:175) TESTING: configureMakeNP from config.packages.make(config/BuildSystem/config/packages/make.py:175) check no of cores on the build machine [perhaps to do make '-j ncores'] module multiprocessing found 4 cores: using make_np = 4 Defined make macro "MAKE_NP" to "4" Defined make macro "MAKE_TEST_NP" to "2" Defined make macro "MAKE_LOAD" to "6.0" Defined make macro "NPMAX" to "4" Defined make macro "OMAKE_PRINTDIR " to "/usr/bin/make --print-directory" Defined make macro "OMAKE" to "/usr/bin/make --no-print-directory" Defined make macro "MAKE_PAR_OUT_FLG" to "--output-sync=recurse" ================================================================================ TEST alternateConfigureLibrary from config.packages.OpenMPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.OpenMPI(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default Executing: uname -s stdout: CYGWIN_NT-6.1 Executing: uname -s stdout: CYGWIN_NT-6.1 ================================================================================ TEST alternateConfigureLibrary from config.packages.MPICH(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.MPICH(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default Pushing language C ================================================================================ TEST checkDependencies from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:721) TESTING: checkDependencies from config.packages.MPI(config/BuildSystem/config/package.py:721) ================================================================================ TEST configureLibrary from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:525) TESTING: configureLibrary from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:525) Calls the regular package configureLibrary and then does an additional test needed by MPI ================================================================================== Checking for a functional MPI Checking for library in User specified MPI libraries: ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] Contents: ['bin', 'etc', 'include', 'lib'] ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [MPI_Init MPI_Comm_create] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char MPI_Init(); static void _check_MPI_Init() { MPI_Init(); } char MPI_Comm_create(); static void _check_MPI_Comm_create() { MPI_Comm_create(); } int main() { _check_MPI_Init(); _check_MPI_Comm_create();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_LIBIMPI" to "1" Popping language C Checking for headers User specified MPI libraries: ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include'] Pushing language C ================================================================================ TEST checkInclude from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:86) TESTING: checkInclude from config.headers(config/BuildSystem/config/headers.py:86) Checks if a particular include file can be found along particular include paths Checking for header files ['mpi.h'] in ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include'] Checking include with compiler flags var CPPFLAGS ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include'] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 85 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 106 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 113 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 122 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 131 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 138 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 148 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 165 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef int MPI_Datatype; #line 190 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 211 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 230 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 264 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 273 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 288 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 301 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 311 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 322 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 338 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef int MPI_Comm; typedef int MPI_Group; typedef int MPI_Win; typedef struct ADIOI_FileD *MPI_File; typedef int MPI_Op; #line 393 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 414 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef enum MPIR_Win_flavor { MPI_WIN_FLAVOR_CREATE = 1, MPI_WIN_FLAVOR_ALLOCATE = 2, MPI_WIN_FLAVOR_DYNAMIC = 3, MPI_WIN_FLAVOR_SHARED = 4 } MPIR_Win_flavor_t; typedef enum MPIR_Win_model { MPI_WIN_SEPARATE = 1, MPI_WIN_UNIFIED = 2 } MPIR_Win_model_t; typedef enum MPIR_Topo_type { MPI_GRAPH=1, MPI_CART=2, MPI_DIST_GRAPH=3 } MPIR_Topo_type; typedef void (MPI_Handler_function) ( MPI_Comm *, int *, ... ); typedef int (MPI_Comm_copy_attr_function)(MPI_Comm, int, void *, void *, void *, int *); typedef int (MPI_Comm_delete_attr_function)(MPI_Comm, int, void *, void *); typedef int (MPI_Type_copy_attr_function)(MPI_Datatype, int, void *, void *, void *, int *); typedef int (MPI_Type_delete_attr_function)(MPI_Datatype, int, void *, void *); typedef int (MPI_Win_copy_attr_function)(MPI_Win, int, void *, void *, void *, int *); typedef int (MPI_Win_delete_attr_function)(MPI_Win, int, void *, void *); typedef void (MPI_Comm_errhandler_function)(MPI_Comm *, int *, ...); typedef void (MPI_File_errhandler_function)(MPI_File *, int *, ...); typedef void (MPI_Win_errhandler_function)(MPI_Win *, int *, ...); typedef MPI_Comm_errhandler_function MPI_Comm_errhandler_fn; typedef MPI_File_errhandler_function MPI_File_errhandler_fn; typedef MPI_Win_errhandler_function MPI_Win_errhandler_fn; typedef int MPI_Errhandler; #line 517 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef int MPI_Request; typedef int MPI_Message; typedef void (MPI_User_function) ( void *, void *, int *, MPI_Datatype * ); typedef int (MPI_Copy_function) ( MPI_Comm, int, void *, void *, void *, int * ); typedef int (MPI_Delete_function) ( MPI_Comm, int, void *, void * ); enum MPIR_Combiner_enum { MPI_COMBINER_NAMED = 1, MPI_COMBINER_DUP = 2, MPI_COMBINER_CONTIGUOUS = 3, MPI_COMBINER_VECTOR = 4, MPI_COMBINER_HVECTOR_INTEGER = 5, MPI_COMBINER_HVECTOR = 6, MPI_COMBINER_INDEXED = 7, MPI_COMBINER_HINDEXED_INTEGER = 8, MPI_COMBINER_HINDEXED = 9, MPI_COMBINER_INDEXED_BLOCK = 10, MPI_COMBINER_STRUCT_INTEGER = 11, MPI_COMBINER_STRUCT = 12, MPI_COMBINER_SUBARRAY = 13, MPI_COMBINER_DARRAY = 14, MPI_COMBINER_F90_REAL = 15, MPI_COMBINER_F90_COMPLEX = 16, MPI_COMBINER_F90_INTEGER = 17, MPI_COMBINER_RESIZED = 18, MPI_COMBINER_HINDEXED_BLOCK = 19 }; typedef int MPI_Info; #line 635 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 657 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef __int64 MPI_Aint; typedef int MPI_Fint; typedef long long MPI_Count; typedef __int64 MPI_Offset; typedef struct MPI_Status { int count_lo; int count_hi_and_cancelled; int MPI_SOURCE; int MPI_TAG; int MPI_ERROR; } MPI_Status; struct MPIR_T_enum_s; struct MPIR_T_cvar_handle_s; struct MPIR_T_pvar_handle_s; struct MPIR_T_pvar_session_s; typedef struct MPIR_T_enum_s * MPI_T_enum; typedef struct MPIR_T_cvar_handle_s * MPI_T_cvar_handle; typedef struct MPIR_T_pvar_handle_s * MPI_T_pvar_handle; typedef struct MPIR_T_pvar_session_s * MPI_T_pvar_session; extern struct MPIR_T_pvar_handle_s * const MPI_T_PVAR_ALL_HANDLES; typedef enum MPIR_T_verbosity_t { MPIX_T_VERBOSITY_INVALID = 0, MPI_T_VERBOSITY_USER_BASIC = 221, MPI_T_VERBOSITY_USER_DETAIL, MPI_T_VERBOSITY_USER_ALL, MPI_T_VERBOSITY_TUNER_BASIC, MPI_T_VERBOSITY_TUNER_DETAIL, MPI_T_VERBOSITY_TUNER_ALL, MPI_T_VERBOSITY_MPIDEV_BASIC, MPI_T_VERBOSITY_MPIDEV_DETAIL, MPI_T_VERBOSITY_MPIDEV_ALL } MPIR_T_verbosity_t; typedef enum MPIR_T_bind_t { MPIX_T_BIND_INVALID = 0, MPI_T_BIND_NO_OBJECT = 9700, MPI_T_BIND_MPI_COMM, MPI_T_BIND_MPI_DATATYPE, MPI_T_BIND_MPI_ERRHANDLER, MPI_T_BIND_MPI_FILE, MPI_T_BIND_MPI_GROUP, MPI_T_BIND_MPI_OP, MPI_T_BIND_MPI_REQUEST, MPI_T_BIND_MPI_WIN, MPI_T_BIND_MPI_MESSAGE, MPI_T_BIND_MPI_INFO } MPIR_T_bind_t; typedef enum MPIR_T_scope_t { MPIX_T_SCOPE_INVALID = 0, MPI_T_SCOPE_CONSTANT = 60438, MPI_T_SCOPE_READONLY, MPI_T_SCOPE_LOCAL, MPI_T_SCOPE_GROUP, MPI_T_SCOPE_GROUP_EQ, MPI_T_SCOPE_ALL, MPI_T_SCOPE_ALL_EQ } MPIR_T_scope_t; typedef enum MPIR_T_pvar_class_t { MPIX_T_PVAR_CLASS_INVALID = 0, MPIR_T_PVAR_CLASS_FIRST = 240, MPI_T_PVAR_CLASS_STATE = MPIR_T_PVAR_CLASS_FIRST, MPI_T_PVAR_CLASS_LEVEL, MPI_T_PVAR_CLASS_SIZE, MPI_T_PVAR_CLASS_PERCENTAGE, MPI_T_PVAR_CLASS_HIGHWATERMARK, MPI_T_PVAR_CLASS_LOWWATERMARK, MPI_T_PVAR_CLASS_COUNTER, MPI_T_PVAR_CLASS_AGGREGATE, MPI_T_PVAR_CLASS_TIMER, MPI_T_PVAR_CLASS_GENERIC, MPIR_T_PVAR_CLASS_LAST, MPIR_T_PVAR_CLASS_NUMBER = MPIR_T_PVAR_CLASS_LAST - MPIR_T_PVAR_CLASS_FIRST } MPIR_T_pvar_class_t; #line 814 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 834 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 850 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" extern __declspec(dllimport) MPI_Fint * MPI_F_STATUS_IGNORE; extern __declspec(dllimport) MPI_Fint * MPI_F_STATUSES_IGNORE; extern __declspec(dllimport) int * const MPI_UNWEIGHTED; extern __declspec(dllimport) int * const MPI_WEIGHTS_EMPTY; typedef struct { MPI_Fint count_lo; MPI_Fint count_hi_and_cancelled; MPI_Fint MPI_SOURCE; MPI_Fint MPI_TAG; MPI_Fint MPI_ERROR; } MPI_F08_Status; extern MPI_F08_Status MPIR_F08_MPI_STATUS_IGNORE_OBJ; extern MPI_F08_Status MPIR_F08_MPI_STATUSES_IGNORE_OBJ[1]; extern int MPIR_F08_MPI_IN_PLACE; extern int MPIR_F08_MPI_BOTTOM; extern MPI_F08_Status *MPI_F08_STATUS_IGNORE; extern MPI_F08_Status *MPI_F08_STATUSES_IGNORE; typedef int (MPI_Grequest_cancel_function)(void *, int); typedef int (MPI_Grequest_free_function)(void *); typedef int (MPI_Grequest_query_function)(void *, MPI_Status *); typedef int (MPIX_Grequest_poll_function)(void *, MPI_Status *); typedef int (MPIX_Grequest_wait_function)(int, void **, double, MPI_Status *); #line 909 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 946 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 963 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 972 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 998 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef int (MPI_Datarep_conversion_function)(void *, MPI_Datatype, int, void *, MPI_Offset, void *); typedef int (MPI_Datarep_extent_function)(MPI_Datatype datatype, MPI_Aint *, void *); int MPI_Send(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int MPI_Recv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Status *status) ; int MPI_Get_count(const MPI_Status *status, MPI_Datatype datatype, int *count); int MPI_Bsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int MPI_Ssend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int MPI_Rsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int MPI_Buffer_attach(void *buffer, int size); int MPI_Buffer_detach(void *buffer_addr, int *size); int MPI_Isend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Ibsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Issend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Irsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Irecv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Wait(MPI_Request *request, MPI_Status *status); int MPI_Test(MPI_Request *request, int *flag, MPI_Status *status); int MPI_Request_free(MPI_Request *request); int MPI_Waitany(int count, MPI_Request array_of_requests[], int *indx, MPI_Status *status); int MPI_Testany(int count, MPI_Request array_of_requests[], int *indx, int *flag, MPI_Status *status); int MPI_Waitall(int count, MPI_Request array_of_requests[], MPI_Status array_of_statuses[]); int MPI_Testall(int count, MPI_Request array_of_requests[], int *flag, MPI_Status array_of_statuses[]); int MPI_Waitsome(int incount, MPI_Request array_of_requests[], int *outcount, int array_of_indices[], MPI_Status array_of_statuses[]); int MPI_Testsome(int incount, MPI_Request array_of_requests[], int *outcount, int array_of_indices[], MPI_Status array_of_statuses[]); int MPI_Iprobe(int source, int tag, MPI_Comm comm, int *flag, MPI_Status *status); int MPI_Probe(int source, int tag, MPI_Comm comm, MPI_Status *status); int MPI_Cancel(MPI_Request *request); int MPI_Test_cancelled(const MPI_Status *status, int *flag); int MPI_Send_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Bsend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Ssend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Rsend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Recv_init(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Start(MPI_Request *request); int MPI_Startall(int count, MPI_Request array_of_requests[]); int MPI_Sendrecv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, int dest, int sendtag, void *recvbuf, int recvcount, MPI_Datatype recvtype, int source, int recvtag, MPI_Comm comm, MPI_Status *status) ; int MPI_Sendrecv_replace(void *buf, int count, MPI_Datatype datatype, int dest, int sendtag, int source, int recvtag, MPI_Comm comm, MPI_Status *status) ; int MPI_Type_contiguous(int count, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_vector(int count, int blocklength, int stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_hvector(int count, int blocklength, MPI_Aint stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_indexed(int count, const int *array_of_blocklengths, const int *array_of_displacements, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_hindexed(int count, const int *array_of_blocklengths, const MPI_Aint *array_of_displacements, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_struct(int count, const int *array_of_blocklengths, const MPI_Aint *array_of_displacements, const MPI_Datatype *array_of_types, MPI_Datatype *newtype); int MPI_Address(const void *location, MPI_Aint *address); int MPI_Type_extent(MPI_Datatype datatype, MPI_Aint *extent); int MPI_Type_size(MPI_Datatype datatype, int *size); int MPI_Type_lb(MPI_Datatype datatype, MPI_Aint *displacement); int MPI_Type_ub(MPI_Datatype datatype, MPI_Aint *displacement); int MPI_Type_commit(MPI_Datatype *datatype); int MPI_Type_free(MPI_Datatype *datatype); int MPI_Get_elements(const MPI_Status *status, MPI_Datatype datatype, int *count); int MPI_Pack(const void *inbuf, int incount, MPI_Datatype datatype, void *outbuf, int outsize, int *position, MPI_Comm comm) ; int MPI_Unpack(const void *inbuf, int insize, int *position, void *outbuf, int outcount, MPI_Datatype datatype, MPI_Comm comm) ; int MPI_Pack_size(int incount, MPI_Datatype datatype, MPI_Comm comm, int *size); int MPI_Barrier(MPI_Comm comm); int MPI_Bcast(void *buffer, int count, MPI_Datatype datatype, int root, MPI_Comm comm) ; int MPI_Gather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int MPI_Gatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *displs, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int MPI_Scatter(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int MPI_Scatterv(const void *sendbuf, const int *sendcounts, const int *displs, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int MPI_Allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *displs, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Alltoallv(const void *sendbuf, const int *sendcounts, const int *sdispls, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *rdispls, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Alltoallw(const void *sendbuf, const int sendcounts[], const int sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const int rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm); int MPI_Exscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int MPI_Reduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, int root, MPI_Comm comm) ; int MPI_Op_create(MPI_User_function *user_fn, int commute, MPI_Op *op); int MPI_Op_free(MPI_Op *op); int MPI_Allreduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int MPI_Reduce_scatter(const void *sendbuf, void *recvbuf, const int recvcounts[], MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int MPI_Scan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int MPI_Group_size(MPI_Group group, int *size); int MPI_Group_rank(MPI_Group group, int *rank); int MPI_Group_translate_ranks(MPI_Group group1, int n, const int ranks1[], MPI_Group group2, int ranks2[]); int MPI_Group_compare(MPI_Group group1, MPI_Group group2, int *result); int MPI_Comm_group(MPI_Comm comm, MPI_Group *group); int MPI_Group_union(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int MPI_Group_intersection(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int MPI_Group_difference(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int MPI_Group_incl(MPI_Group group, int n, const int ranks[], MPI_Group *newgroup); int MPI_Group_excl(MPI_Group group, int n, const int ranks[], MPI_Group *newgroup); int MPI_Group_range_incl(MPI_Group group, int n, int ranges[][3], MPI_Group *newgroup); int MPI_Group_range_excl(MPI_Group group, int n, int ranges[][3], MPI_Group *newgroup); int MPI_Group_free(MPI_Group *group); int MPI_Comm_size(MPI_Comm comm, int *size); int MPI_Comm_rank(MPI_Comm comm, int *rank); int MPI_Comm_compare(MPI_Comm comm1, MPI_Comm comm2, int *result); int MPI_Comm_dup(MPI_Comm comm, MPI_Comm *newcomm); int MPI_Comm_dup_with_info(MPI_Comm comm, MPI_Info info, MPI_Comm *newcomm); int MPI_Comm_create(MPI_Comm comm, MPI_Group group, MPI_Comm *newcomm); int MPI_Comm_split(MPI_Comm comm, int color, int key, MPI_Comm *newcomm); int MPI_Comm_free(MPI_Comm *comm); int MPI_Comm_test_inter(MPI_Comm comm, int *flag); int MPI_Comm_remote_size(MPI_Comm comm, int *size); int MPI_Comm_remote_group(MPI_Comm comm, MPI_Group *group); int MPI_Intercomm_create(MPI_Comm local_comm, int local_leader, MPI_Comm peer_comm, int remote_leader, int tag, MPI_Comm *newintercomm); int MPI_Intercomm_merge(MPI_Comm intercomm, int high, MPI_Comm *newintracomm); int MPI_Keyval_create(MPI_Copy_function *copy_fn, MPI_Delete_function *delete_fn, int *keyval, void *extra_state); int MPI_Keyval_free(int *keyval); int MPI_Attr_put(MPI_Comm comm, int keyval, void *attribute_val); int MPI_Attr_get(MPI_Comm comm, int keyval, void *attribute_val, int *flag); int MPI_Attr_delete(MPI_Comm comm, int keyval); int MPI_Topo_test(MPI_Comm comm, int *status); int MPI_Cart_create(MPI_Comm comm_old, int ndims, const int dims[], const int periods[], int reorder, MPI_Comm *comm_cart); int MPI_Dims_create(int nnodes, int ndims, int dims[]); int MPI_Graph_create(MPI_Comm comm_old, int nnodes, const int indx[], const int edges[], int reorder, MPI_Comm *comm_graph); int MPI_Graphdims_get(MPI_Comm comm, int *nnodes, int *nedges); int MPI_Graph_get(MPI_Comm comm, int maxindex, int maxedges, int indx[], int edges[]); int MPI_Cartdim_get(MPI_Comm comm, int *ndims); int MPI_Cart_get(MPI_Comm comm, int maxdims, int dims[], int periods[], int coords[]); int MPI_Cart_rank(MPI_Comm comm, const int coords[], int *rank); int MPI_Cart_coords(MPI_Comm comm, int rank, int maxdims, int coords[]); int MPI_Graph_neighbors_count(MPI_Comm comm, int rank, int *nneighbors); int MPI_Graph_neighbors(MPI_Comm comm, int rank, int maxneighbors, int neighbors[]); int MPI_Cart_shift(MPI_Comm comm, int direction, int disp, int *rank_source, int *rank_dest); int MPI_Cart_sub(MPI_Comm comm, const int remain_dims[], MPI_Comm *newcomm); int MPI_Cart_map(MPI_Comm comm, int ndims, const int dims[], const int periods[], int *newrank); int MPI_Graph_map(MPI_Comm comm, int nnodes, const int indx[], const int edges[], int *newrank); int MPI_Get_processor_name(char *name, int *resultlen); int MPI_Get_version(int *version, int *subversion); int MPI_Get_library_version(char *version, int *resultlen); int MPI_Errhandler_create(MPI_Handler_function *function, MPI_Errhandler *errhandler); int MPI_Errhandler_set(MPI_Comm comm, MPI_Errhandler errhandler); int MPI_Errhandler_get(MPI_Comm comm, MPI_Errhandler *errhandler); int MPI_Errhandler_free(MPI_Errhandler *errhandler); int MPI_Error_string(int errorcode, char *string, int *resultlen); int MPI_Error_class(int errorcode, int *errorclass); double MPI_Wtime(void); double MPI_Wtick(void); int MPI_Init(int *argc, char ***argv); int MPI_Finalize(void); int MPI_Initialized(int *flag); int MPI_Abort(MPI_Comm comm, int errorcode); int MPI_Pcontrol(const int level, ...); int MPIR_Dup_fn(MPI_Comm oldcomm, int keyval, void *extra_state, void *attribute_val_in, void *attribute_val_out, int *flag); int MPI_Close_port(const char *port_name); int MPI_Comm_accept(const char *port_name, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *newcomm); int MPI_Comm_connect(const char *port_name, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *newcomm); int MPI_Comm_disconnect(MPI_Comm *comm); int MPI_Comm_get_parent(MPI_Comm *parent); int MPI_Comm_join(int fd, MPI_Comm *intercomm); int MPI_Comm_spawn(const char *command, char *argv[], int maxprocs, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *intercomm, int array_of_errcodes[]); int MPI_Comm_spawn_multiple(int count, char *array_of_commands[], char **array_of_argv[], const int array_of_maxprocs[], const MPI_Info array_of_info[], int root, MPI_Comm comm, MPI_Comm *intercomm, int array_of_errcodes[]); int MPI_Lookup_name(const char *service_name, MPI_Info info, char *port_name); int MPI_Open_port(MPI_Info info, char *port_name); int MPI_Publish_name(const char *service_name, MPI_Info info, const char *port_name); int MPI_Unpublish_name(const char *service_name, MPI_Info info, const char *port_name); int MPI_Comm_set_info(MPI_Comm comm, MPI_Info info); int MPI_Comm_get_info(MPI_Comm comm, MPI_Info *info); int MPI_Accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win) ; int MPI_Get(void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win) ; int MPI_Put(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win) ; int MPI_Win_complete(MPI_Win win); int MPI_Win_create(void *base, MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, MPI_Win *win); int MPI_Win_fence(int assert, MPI_Win win); int MPI_Win_free(MPI_Win *win); int MPI_Win_get_group(MPI_Win win, MPI_Group *group); int MPI_Win_lock(int lock_type, int rank, int assert, MPI_Win win); int MPI_Win_post(MPI_Group group, int assert, MPI_Win win); int MPI_Win_start(MPI_Group group, int assert, MPI_Win win); int MPI_Win_test(MPI_Win win, int *flag); int MPI_Win_unlock(int rank, MPI_Win win); int MPI_Win_wait(MPI_Win win); int MPI_Win_allocate(MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, void *baseptr, MPI_Win *win); int MPI_Win_allocate_shared(MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, void *baseptr, MPI_Win *win); int MPI_Win_shared_query(MPI_Win win, int rank, MPI_Aint *size, int *disp_unit, void *baseptr); int MPI_Win_create_dynamic(MPI_Info info, MPI_Comm comm, MPI_Win *win); int MPI_Win_attach(MPI_Win win, void *base, MPI_Aint size); int MPI_Win_detach(MPI_Win win, const void *base); int MPI_Win_get_info(MPI_Win win, MPI_Info *info_used); int MPI_Win_set_info(MPI_Win win, MPI_Info info); int MPI_Get_accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, void *result_addr, int result_count, MPI_Datatype result_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win) ; int MPI_Fetch_and_op(const void *origin_addr, void *result_addr, MPI_Datatype datatype, int target_rank, MPI_Aint target_disp, MPI_Op op, MPI_Win win) ; int MPI_Compare_and_swap(const void *origin_addr, const void *compare_addr, void *result_addr, MPI_Datatype datatype, int target_rank, MPI_Aint target_disp, MPI_Win win) ; int MPI_Rput(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win, MPI_Request *request) ; int MPI_Rget(void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win, MPI_Request *request) ; int MPI_Raccumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win, MPI_Request *request) ; int MPI_Rget_accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, void *result_addr, int result_count, MPI_Datatype result_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win, MPI_Request *request) ; int MPI_Win_lock_all(int assert, MPI_Win win); int MPI_Win_unlock_all(MPI_Win win); int MPI_Win_flush(int rank, MPI_Win win); int MPI_Win_flush_all(MPI_Win win); int MPI_Win_flush_local(int rank, MPI_Win win); int MPI_Win_flush_local_all(MPI_Win win); int MPI_Win_sync(MPI_Win win); int MPI_Add_error_class(int *errorclass); int MPI_Add_error_code(int errorclass, int *errorcode); int MPI_Add_error_string(int errorcode, const char *string); int MPI_Comm_call_errhandler(MPI_Comm comm, int errorcode); int MPI_Comm_create_keyval(MPI_Comm_copy_attr_function *comm_copy_attr_fn, MPI_Comm_delete_attr_function *comm_delete_attr_fn, int *comm_keyval, void *extra_state); int MPI_Comm_delete_attr(MPI_Comm comm, int comm_keyval); int MPI_Comm_free_keyval(int *comm_keyval); int MPI_Comm_get_attr(MPI_Comm comm, int comm_keyval, void *attribute_val, int *flag); int MPI_Comm_get_name(MPI_Comm comm, char *comm_name, int *resultlen); int MPI_Comm_set_attr(MPI_Comm comm, int comm_keyval, void *attribute_val); int MPI_Comm_set_name(MPI_Comm comm, const char *comm_name); int MPI_File_call_errhandler(MPI_File fh, int errorcode); int MPI_Grequest_complete(MPI_Request request); int MPI_Grequest_start(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, void *extra_state, MPI_Request *request); int MPI_Init_thread(int *argc, char ***argv, int required, int *provided); int MPI_Is_thread_main(int *flag); int MPI_Query_thread(int *provided); int MPI_Status_set_cancelled(MPI_Status *status, int flag); int MPI_Status_set_elements(MPI_Status *status, MPI_Datatype datatype, int count); int MPI_Type_create_keyval(MPI_Type_copy_attr_function *type_copy_attr_fn, MPI_Type_delete_attr_function *type_delete_attr_fn, int *type_keyval, void *extra_state); int MPI_Type_delete_attr(MPI_Datatype datatype, int type_keyval); int MPI_Type_dup(MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_free_keyval(int *type_keyval); int MPI_Type_get_attr(MPI_Datatype datatype, int type_keyval, void *attribute_val, int *flag); int MPI_Type_get_contents(MPI_Datatype datatype, int max_integers, int max_addresses, int max_datatypes, int array_of_integers[], MPI_Aint array_of_addresses[], MPI_Datatype array_of_datatypes[]); int MPI_Type_get_envelope(MPI_Datatype datatype, int *num_integers, int *num_addresses, int *num_datatypes, int *combiner); int MPI_Type_get_name(MPI_Datatype datatype, char *type_name, int *resultlen); int MPI_Type_set_attr(MPI_Datatype datatype, int type_keyval, void *attribute_val); int MPI_Type_set_name(MPI_Datatype datatype, const char *type_name); int MPI_Type_match_size(int typeclass, int size, MPI_Datatype *datatype); int MPI_Win_call_errhandler(MPI_Win win, int errorcode); int MPI_Win_create_keyval(MPI_Win_copy_attr_function *win_copy_attr_fn, MPI_Win_delete_attr_function *win_delete_attr_fn, int *win_keyval, void *extra_state); int MPI_Win_delete_attr(MPI_Win win, int win_keyval); int MPI_Win_free_keyval(int *win_keyval); int MPI_Win_get_attr(MPI_Win win, int win_keyval, void *attribute_val, int *flag); int MPI_Win_get_name(MPI_Win win, char *win_name, int *resultlen); int MPI_Win_set_attr(MPI_Win win, int win_keyval, void *attribute_val); int MPI_Win_set_name(MPI_Win win, const char *win_name); int MPI_Alloc_mem(MPI_Aint size, MPI_Info info, void *baseptr); int MPI_Comm_create_errhandler(MPI_Comm_errhandler_function *comm_errhandler_fn, MPI_Errhandler *errhandler); int MPI_Comm_get_errhandler(MPI_Comm comm, MPI_Errhandler *errhandler); int MPI_Comm_set_errhandler(MPI_Comm comm, MPI_Errhandler errhandler); int MPI_File_create_errhandler(MPI_File_errhandler_function *file_errhandler_fn, MPI_Errhandler *errhandler); int MPI_File_get_errhandler(MPI_File file, MPI_Errhandler *errhandler); int MPI_File_set_errhandler(MPI_File file, MPI_Errhandler errhandler); int MPI_Finalized(int *flag); int MPI_Free_mem(void *base); int MPI_Get_address(const void *location, MPI_Aint *address); int MPI_Info_create(MPI_Info *info); int MPI_Info_delete(MPI_Info info, const char *key); int MPI_Info_dup(MPI_Info info, MPI_Info *newinfo); int MPI_Info_free(MPI_Info *info); int MPI_Info_get(MPI_Info info, const char *key, int valuelen, char *value, int *flag); int MPI_Info_get_nkeys(MPI_Info info, int *nkeys); int MPI_Info_get_nthkey(MPI_Info info, int n, char *key); int MPI_Info_get_valuelen(MPI_Info info, const char *key, int *valuelen, int *flag); int MPI_Info_set(MPI_Info info, const char *key, const char *value); int MPI_Pack_external(const char datarep[], const void *inbuf, int incount, MPI_Datatype datatype, void *outbuf, MPI_Aint outsize, MPI_Aint *position) ; int MPI_Pack_external_size(const char datarep[], int incount, MPI_Datatype datatype, MPI_Aint *size); int MPI_Request_get_status(MPI_Request request, int *flag, MPI_Status *status); int MPI_Status_c2f(const MPI_Status *c_status, MPI_Fint *f_status); int MPI_Status_f2c(const MPI_Fint *f_status, MPI_Status *c_status); int MPI_Type_create_darray(int size, int rank, int ndims, const int array_of_gsizes[], const int array_of_distribs[], const int array_of_dargs[], const int array_of_psizes[], int order, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_create_hindexed(int count, const int array_of_blocklengths[], const MPI_Aint array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_create_hvector(int count, int blocklength, MPI_Aint stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_create_indexed_block(int count, int blocklength, const int array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_create_hindexed_block(int count, int blocklength, const MPI_Aint array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_create_resized(MPI_Datatype oldtype, MPI_Aint lb, MPI_Aint extent, MPI_Datatype *newtype); int MPI_Type_create_struct(int count, const int array_of_blocklengths[], const MPI_Aint array_of_displacements[], const MPI_Datatype array_of_types[], MPI_Datatype *newtype); int MPI_Type_create_subarray(int ndims, const int array_of_sizes[], const int array_of_subsizes[], const int array_of_starts[], int order, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_get_extent(MPI_Datatype datatype, MPI_Aint *lb, MPI_Aint *extent); int MPI_Type_get_true_extent(MPI_Datatype datatype, MPI_Aint *true_lb, MPI_Aint *true_extent); int MPI_Unpack_external(const char datarep[], const void *inbuf, MPI_Aint insize, MPI_Aint *position, void *outbuf, int outcount, MPI_Datatype datatype) ; int MPI_Win_create_errhandler(MPI_Win_errhandler_function *win_errhandler_fn, MPI_Errhandler *errhandler); int MPI_Win_get_errhandler(MPI_Win win, MPI_Errhandler *errhandler); int MPI_Win_set_errhandler(MPI_Win win, MPI_Errhandler errhandler); int MPI_Type_create_f90_integer(int range, MPI_Datatype *newtype); int MPI_Type_create_f90_real(int precision, int range, MPI_Datatype *newtype); int MPI_Type_create_f90_complex(int precision, int range, MPI_Datatype *newtype); int MPI_Reduce_local(const void *inbuf, void *inoutbuf, int count, MPI_Datatype datatype, MPI_Op op) ; int MPI_Op_commutative(MPI_Op op, int *commute); int MPI_Reduce_scatter_block(const void *sendbuf, void *recvbuf, int recvcount, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int MPI_Dist_graph_create_adjacent(MPI_Comm comm_old, int indegree, const int sources[], const int sourceweights[], int outdegree, const int destinations[], const int destweights[], MPI_Info info, int reorder, MPI_Comm *comm_dist_graph); int MPI_Dist_graph_create(MPI_Comm comm_old, int n, const int sources[], const int degrees[], const int destinations[], const int weights[], MPI_Info info, int reorder, MPI_Comm *comm_dist_graph); int MPI_Dist_graph_neighbors_count(MPI_Comm comm, int *indegree, int *outdegree, int *weighted); int MPI_Dist_graph_neighbors(MPI_Comm comm, int maxindegree, int sources[], int sourceweights[], int maxoutdegree, int destinations[], int destweights[]); int MPI_Improbe(int source, int tag, MPI_Comm comm, int *flag, MPI_Message *message, MPI_Status *status); int MPI_Imrecv(void *buf, int count, MPI_Datatype datatype, MPI_Message *message, MPI_Request *request) ; int MPI_Mprobe(int source, int tag, MPI_Comm comm, MPI_Message *message, MPI_Status *status); int MPI_Mrecv(void *buf, int count, MPI_Datatype datatype, MPI_Message *message, MPI_Status *status) ; int MPI_Comm_idup(MPI_Comm comm, MPI_Comm *newcomm, MPI_Request *request); int MPI_Ibarrier(MPI_Comm comm, MPI_Request *request); int MPI_Ibcast(void *buffer, int count, MPI_Datatype datatype, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Igather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Igatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Iscatter(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Iscatterv(const void *sendbuf, const int sendcounts[], const int displs[], MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Iallgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Iallgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ialltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ialltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ialltoallw(const void *sendbuf, const int sendcounts[], const int sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const int rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm, MPI_Request *request); int MPI_Ireduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Iallreduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int MPI_Ireduce_scatter(const void *sendbuf, void *recvbuf, const int recvcounts[], MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int MPI_Ireduce_scatter_block(const void *sendbuf, void *recvbuf, int recvcount, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int MPI_Iscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int MPI_Iexscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int MPI_Ineighbor_allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ineighbor_allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ineighbor_alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ineighbor_alltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ineighbor_alltoallw(const void *sendbuf, const int sendcounts[], const MPI_Aint sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const MPI_Aint rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm, MPI_Request *request); int MPI_Neighbor_allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Neighbor_allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Neighbor_alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Neighbor_alltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Neighbor_alltoallw(const void *sendbuf, const int sendcounts[], const MPI_Aint sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const MPI_Aint rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm); int MPI_Comm_split_type(MPI_Comm comm, int split_type, int key, MPI_Info info, MPI_Comm *newcomm); int MPI_Get_elements_x(const MPI_Status *status, MPI_Datatype datatype, MPI_Count *count); int MPI_Status_set_elements_x(MPI_Status *status, MPI_Datatype datatype, MPI_Count count); int MPI_Type_get_extent_x(MPI_Datatype datatype, MPI_Count *lb, MPI_Count *extent); int MPI_Type_get_true_extent_x(MPI_Datatype datatype, MPI_Count *lb, MPI_Count *extent); int MPI_Type_size_x(MPI_Datatype datatype, MPI_Count *size); int MPI_Comm_create_group(MPI_Comm comm, MPI_Group group, int tag, MPI_Comm *newcomm); MPI_Aint MPI_Aint_add(MPI_Aint base, MPI_Aint disp); MPI_Aint MPI_Aint_diff(MPI_Aint addr1, MPI_Aint addr2); int MPI_T_init_thread(int required, int *provided); int MPI_T_finalize(void); int MPI_T_enum_get_info(MPI_T_enum enumtype, int *num, char *name, int *name_len); int MPI_T_enum_get_item(MPI_T_enum enumtype, int indx, int *value, char *name, int *name_len); int MPI_T_cvar_get_num(int *num_cvar); int MPI_T_cvar_get_info(int cvar_index, char *name, int *name_len, int *verbosity, MPI_Datatype *datatype, MPI_T_enum *enumtype, char *desc, int *desc_len, int *binding, int *scope); int MPI_T_cvar_handle_alloc(int cvar_index, void *obj_handle, MPI_T_cvar_handle *handle, int *count); int MPI_T_cvar_handle_free(MPI_T_cvar_handle *handle); int MPI_T_cvar_read(MPI_T_cvar_handle handle, void *buf); int MPI_T_cvar_write(MPI_T_cvar_handle handle, const void *buf); int MPI_T_pvar_get_num(int *num_pvar); int MPI_T_pvar_get_info(int pvar_index, char *name, int *name_len, int *verbosity, int *var_class, MPI_Datatype *datatype, MPI_T_enum *enumtype, char *desc, int *desc_len, int *binding, int *readonly, int *continuous, int *atomic); int MPI_T_pvar_session_create(MPI_T_pvar_session *session); int MPI_T_pvar_session_free(MPI_T_pvar_session *session); int MPI_T_pvar_handle_alloc(MPI_T_pvar_session session, int pvar_index, void *obj_handle, MPI_T_pvar_handle *handle, int *count); int MPI_T_pvar_handle_free(MPI_T_pvar_session session, MPI_T_pvar_handle *handle); int MPI_T_pvar_start(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int MPI_T_pvar_stop(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int MPI_T_pvar_read(MPI_T_pvar_session session, MPI_T_pvar_handle handle, void *buf); int MPI_T_pvar_write(MPI_T_pvar_session session, MPI_T_pvar_handle handle, const void *buf); int MPI_T_pvar_reset(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int MPI_T_pvar_readreset(MPI_T_pvar_session session, MPI_T_pvar_handle handle, void *buf); int MPI_T_category_get_num(int *num_cat); int MPI_T_category_get_info(int cat_index, char *name, int *name_len, char *desc, int *desc_len, int *num_cvars, int *num_pvars, int *num_categories); int MPI_T_category_get_cvars(int cat_index, int len, int indices[]); int MPI_T_category_get_pvars(int cat_index, int len, int indices[]); int MPI_T_category_get_categories(int cat_index, int len, int indices[]); int MPI_T_category_changed(int *stamp); int MPI_T_cvar_get_index(const char *name, int *cvar_index); int MPI_T_pvar_get_index(const char *name, int var_class, int *pvar_index); int MPI_T_category_get_index(const char *name, int *cat_index); int MPIX_Comm_failure_ack(MPI_Comm comm); int MPIX_Comm_failure_get_acked(MPI_Comm comm, MPI_Group *failedgrp); int MPIX_Comm_revoke(MPI_Comm comm); int MPIX_Comm_shrink(MPI_Comm comm, MPI_Comm *newcomm); int MPIX_Comm_agree(MPI_Comm comm, int *flag); int PMPI_Send(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int PMPI_Recv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Status *status) ; int PMPI_Get_count(const MPI_Status *status, MPI_Datatype datatype, int *count); int PMPI_Bsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int PMPI_Ssend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int PMPI_Rsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int PMPI_Buffer_attach(void *buffer, int size); int PMPI_Buffer_detach(void *buffer_addr, int *size); int PMPI_Isend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ibsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Issend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Irsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Irecv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Wait(MPI_Request *request, MPI_Status *status); int PMPI_Test(MPI_Request *request, int *flag, MPI_Status *status); int PMPI_Request_free(MPI_Request *request); int PMPI_Waitany(int count, MPI_Request array_of_requests[], int *indx, MPI_Status *status); int PMPI_Testany(int count, MPI_Request array_of_requests[], int *indx, int *flag, MPI_Status *status); int PMPI_Waitall(int count, MPI_Request array_of_requests[], MPI_Status array_of_statuses[]); int PMPI_Testall(int count, MPI_Request array_of_requests[], int *flag, MPI_Status array_of_statuses[]); int PMPI_Waitsome(int incount, MPI_Request array_of_requests[], int *outcount, int array_of_indices[], MPI_Status array_of_statuses[]); int PMPI_Testsome(int incount, MPI_Request array_of_requests[], int *outcount, int array_of_indices[], MPI_Status array_of_statuses[]); int PMPI_Iprobe(int source, int tag, MPI_Comm comm, int *flag, MPI_Status *status); int PMPI_Probe(int source, int tag, MPI_Comm comm, MPI_Status *status); int PMPI_Cancel(MPI_Request *request); int PMPI_Test_cancelled(const MPI_Status *status, int *flag); int PMPI_Send_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Bsend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ssend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Rsend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Recv_init(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Start(MPI_Request *request); int PMPI_Startall(int count, MPI_Request array_of_requests[]); int PMPI_Sendrecv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, int dest, int sendtag, void *recvbuf, int recvcount, MPI_Datatype recvtype, int source, int recvtag, MPI_Comm comm, MPI_Status *status) ; int PMPI_Sendrecv_replace(void *buf, int count, MPI_Datatype datatype, int dest, int sendtag, int source, int recvtag, MPI_Comm comm, MPI_Status *status) ; int PMPI_Type_contiguous(int count, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_vector(int count, int blocklength, int stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_hvector(int count, int blocklength, MPI_Aint stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_indexed(int count, const int *array_of_blocklengths, const int *array_of_displacements, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_hindexed(int count, const int *array_of_blocklengths, const MPI_Aint *array_of_displacements, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_struct(int count, const int *array_of_blocklengths, const MPI_Aint *array_of_displacements, const MPI_Datatype *array_of_types, MPI_Datatype *newtype); int PMPI_Address(const void *location, MPI_Aint *address); int PMPI_Type_extent(MPI_Datatype datatype, MPI_Aint *extent); int PMPI_Type_size(MPI_Datatype datatype, int *size); int PMPI_Type_lb(MPI_Datatype datatype, MPI_Aint *displacement); int PMPI_Type_ub(MPI_Datatype datatype, MPI_Aint *displacement); int PMPI_Type_commit(MPI_Datatype *datatype); int PMPI_Type_free(MPI_Datatype *datatype); int PMPI_Get_elements(const MPI_Status *status, MPI_Datatype datatype, int *count); int PMPI_Pack(const void *inbuf, int incount, MPI_Datatype datatype, void *outbuf, int outsize, int *position, MPI_Comm comm) ; int PMPI_Unpack(const void *inbuf, int insize, int *position, void *outbuf, int outcount, MPI_Datatype datatype, MPI_Comm comm) ; int PMPI_Pack_size(int incount, MPI_Datatype datatype, MPI_Comm comm, int *size); int PMPI_Barrier(MPI_Comm comm); int PMPI_Bcast(void *buffer, int count, MPI_Datatype datatype, int root, MPI_Comm comm) ; int PMPI_Gather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int PMPI_Gatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *displs, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int PMPI_Scatter(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int PMPI_Scatterv(const void *sendbuf, const int *sendcounts, const int *displs, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int PMPI_Allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *displs, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Alltoallv(const void *sendbuf, const int *sendcounts, const int *sdispls, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *rdispls, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Alltoallw(const void *sendbuf, const int sendcounts[], const int sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const int rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm); int PMPI_Exscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int PMPI_Reduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, int root, MPI_Comm comm) ; int PMPI_Op_create(MPI_User_function *user_fn, int commute, MPI_Op *op); int PMPI_Op_free(MPI_Op *op); int PMPI_Allreduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int PMPI_Reduce_scatter(const void *sendbuf, void *recvbuf, const int recvcounts[], MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int PMPI_Scan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int PMPI_Group_size(MPI_Group group, int *size); int PMPI_Group_rank(MPI_Group group, int *rank); int PMPI_Group_translate_ranks(MPI_Group group1, int n, const int ranks1[], MPI_Group group2, int ranks2[]); int PMPI_Group_compare(MPI_Group group1, MPI_Group group2, int *result); int PMPI_Comm_group(MPI_Comm comm, MPI_Group *group); int PMPI_Group_union(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int PMPI_Group_intersection(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int PMPI_Group_difference(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int PMPI_Group_incl(MPI_Group group, int n, const int ranks[], MPI_Group *newgroup); int PMPI_Group_excl(MPI_Group group, int n, const int ranks[], MPI_Group *newgroup); int PMPI_Group_range_incl(MPI_Group group, int n, int ranges[][3], MPI_Group *newgroup); int PMPI_Group_range_excl(MPI_Group group, int n, int ranges[][3], MPI_Group *newgroup); int PMPI_Group_free(MPI_Group *group); int PMPI_Comm_size(MPI_Comm comm, int *size); int PMPI_Comm_rank(MPI_Comm comm, int *rank); int PMPI_Comm_compare(MPI_Comm comm1, MPI_Comm comm2, int *result); int PMPI_Comm_dup(MPI_Comm comm, MPI_Comm *newcomm); int PMPI_Comm_dup_with_info(MPI_Comm comm, MPI_Info info, MPI_Comm *newcomm); int PMPI_Comm_create(MPI_Comm comm, MPI_Group group, MPI_Comm *newcomm); int PMPI_Comm_split(MPI_Comm comm, int color, int key, MPI_Comm *newcomm); int PMPI_Comm_free(MPI_Comm *comm); int PMPI_Comm_test_inter(MPI_Comm comm, int *flag); int PMPI_Comm_remote_size(MPI_Comm comm, int *size); int PMPI_Comm_remote_group(MPI_Comm comm, MPI_Group *group); int PMPI_Intercomm_create(MPI_Comm local_comm, int local_leader, MPI_Comm peer_comm, int remote_leader, int tag, MPI_Comm *newintercomm); int PMPI_Intercomm_merge(MPI_Comm intercomm, int high, MPI_Comm *newintracomm); int PMPI_Keyval_create(MPI_Copy_function *copy_fn, MPI_Delete_function *delete_fn, int *keyval, void *extra_state); int PMPI_Keyval_free(int *keyval); int PMPI_Attr_put(MPI_Comm comm, int keyval, void *attribute_val); int PMPI_Attr_get(MPI_Comm comm, int keyval, void *attribute_val, int *flag); int PMPI_Attr_delete(MPI_Comm comm, int keyval); int PMPI_Topo_test(MPI_Comm comm, int *status); int PMPI_Cart_create(MPI_Comm comm_old, int ndims, const int dims[], const int periods[], int reorder, MPI_Comm *comm_cart); int PMPI_Dims_create(int nnodes, int ndims, int dims[]); int PMPI_Graph_create(MPI_Comm comm_old, int nnodes, const int indx[], const int edges[], int reorder, MPI_Comm *comm_graph); int PMPI_Graphdims_get(MPI_Comm comm, int *nnodes, int *nedges); int PMPI_Graph_get(MPI_Comm comm, int maxindex, int maxedges, int indx[], int edges[]); int PMPI_Cartdim_get(MPI_Comm comm, int *ndims); int PMPI_Cart_get(MPI_Comm comm, int maxdims, int dims[], int periods[], int coords[]); int PMPI_Cart_rank(MPI_Comm comm, const int coords[], int *rank); int PMPI_Cart_coords(MPI_Comm comm, int rank, int maxdims, int coords[]); int PMPI_Graph_neighbors_count(MPI_Comm comm, int rank, int *nneighbors); int PMPI_Graph_neighbors(MPI_Comm comm, int rank, int maxneighbors, int neighbors[]); int PMPI_Cart_shift(MPI_Comm comm, int direction, int disp, int *rank_source, int *rank_dest); int PMPI_Cart_sub(MPI_Comm comm, const int remain_dims[], MPI_Comm *newcomm); int PMPI_Cart_map(MPI_Comm comm, int ndims, const int dims[], const int periods[], int *newrank); int PMPI_Graph_map(MPI_Comm comm, int nnodes, const int indx[], const int edges[], int *newrank); int PMPI_Get_processor_name(char *name, int *resultlen); int PMPI_Get_version(int *version, int *subversion); int PMPI_Get_library_version(char *version, int *resultlen); int PMPI_Errhandler_create(MPI_Handler_function *function, MPI_Errhandler *errhandler); int PMPI_Errhandler_set(MPI_Comm comm, MPI_Errhandler errhandler); int PMPI_Errhandler_get(MPI_Comm comm, MPI_Errhandler *errhandler); int PMPI_Errhandler_free(MPI_Errhandler *errhandler); int PMPI_Error_string(int errorcode, char *string, int *resultlen); int PMPI_Error_class(int errorcode, int *errorclass); double PMPI_Wtime(void); double PMPI_Wtick(void); int PMPI_Init(int *argc, char ***argv); int PMPI_Finalize(void); int PMPI_Initialized(int *flag); int PMPI_Abort(MPI_Comm comm, int errorcode); int PMPI_Pcontrol(const int level, ...); int PMPI_Close_port(const char *port_name); int PMPI_Comm_accept(const char *port_name, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *newcomm); int PMPI_Comm_connect(const char *port_name, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *newcomm); int PMPI_Comm_disconnect(MPI_Comm *comm); int PMPI_Comm_get_parent(MPI_Comm *parent); int PMPI_Comm_join(int fd, MPI_Comm *intercomm); int PMPI_Comm_spawn(const char *command, char *argv[], int maxprocs, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *intercomm, int array_of_errcodes[]); int PMPI_Comm_spawn_multiple(int count, char *array_of_commands[], char **array_of_argv[], const int array_of_maxprocs[], const MPI_Info array_of_info[], int root, MPI_Comm comm, MPI_Comm *intercomm, int array_of_errcodes[]); int PMPI_Lookup_name(const char *service_name, MPI_Info info, char *port_name); int PMPI_Open_port(MPI_Info info, char *port_name); int PMPI_Publish_name(const char *service_name, MPI_Info info, const char *port_name); int PMPI_Unpublish_name(const char *service_name, MPI_Info info, const char *port_name); int PMPI_Comm_set_info(MPI_Comm comm, MPI_Info info); int PMPI_Comm_get_info(MPI_Comm comm, MPI_Info *info); int PMPI_Accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win) ; int PMPI_Get(void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win) ; int PMPI_Put(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win) ; int PMPI_Win_complete(MPI_Win win); int PMPI_Win_create(void *base, MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, MPI_Win *win); int PMPI_Win_fence(int assert, MPI_Win win); int PMPI_Win_free(MPI_Win *win); int PMPI_Win_get_group(MPI_Win win, MPI_Group *group); int PMPI_Win_lock(int lock_type, int rank, int assert, MPI_Win win); int PMPI_Win_post(MPI_Group group, int assert, MPI_Win win); int PMPI_Win_start(MPI_Group group, int assert, MPI_Win win); int PMPI_Win_test(MPI_Win win, int *flag); int PMPI_Win_unlock(int rank, MPI_Win win); int PMPI_Win_wait(MPI_Win win); int PMPI_Win_allocate(MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, void *baseptr, MPI_Win *win); int PMPI_Win_allocate_shared(MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, void *baseptr, MPI_Win *win); int PMPI_Win_shared_query(MPI_Win win, int rank, MPI_Aint *size, int *disp_unit, void *baseptr); int PMPI_Win_create_dynamic(MPI_Info info, MPI_Comm comm, MPI_Win *win); int PMPI_Win_attach(MPI_Win win, void *base, MPI_Aint size); int PMPI_Win_detach(MPI_Win win, const void *base); int PMPI_Win_get_info(MPI_Win win, MPI_Info *info_used); int PMPI_Win_set_info(MPI_Win win, MPI_Info info); int PMPI_Get_accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, void *result_addr, int result_count, MPI_Datatype result_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win) ; int PMPI_Fetch_and_op(const void *origin_addr, void *result_addr, MPI_Datatype datatype, int target_rank, MPI_Aint target_disp, MPI_Op op, MPI_Win win) ; int PMPI_Compare_and_swap(const void *origin_addr, const void *compare_addr, void *result_addr, MPI_Datatype datatype, int target_rank, MPI_Aint target_disp, MPI_Win win) ; int PMPI_Rput(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win, MPI_Request *request) ; int PMPI_Rget(void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win, MPI_Request *request) ; int PMPI_Raccumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win, MPI_Request *request) ; int PMPI_Rget_accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, void *result_addr, int result_count, MPI_Datatype result_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win, MPI_Request *request) ; int PMPI_Win_lock_all(int assert, MPI_Win win); int PMPI_Win_unlock_all(MPI_Win win); int PMPI_Win_flush(int rank, MPI_Win win); int PMPI_Win_flush_all(MPI_Win win); int PMPI_Win_flush_local(int rank, MPI_Win win); int PMPI_Win_flush_local_all(MPI_Win win); int PMPI_Win_sync(MPI_Win win); int PMPI_Add_error_class(int *errorclass); int PMPI_Add_error_code(int errorclass, int *errorcode); int PMPI_Add_error_string(int errorcode, const char *string); int PMPI_Comm_call_errhandler(MPI_Comm comm, int errorcode); int PMPI_Comm_create_keyval(MPI_Comm_copy_attr_function *comm_copy_attr_fn, MPI_Comm_delete_attr_function *comm_delete_attr_fn, int *comm_keyval, void *extra_state); int PMPI_Comm_delete_attr(MPI_Comm comm, int comm_keyval); int PMPI_Comm_free_keyval(int *comm_keyval); int PMPI_Comm_get_attr(MPI_Comm comm, int comm_keyval, void *attribute_val, int *flag); int PMPI_Comm_get_name(MPI_Comm comm, char *comm_name, int *resultlen); int PMPI_Comm_set_attr(MPI_Comm comm, int comm_keyval, void *attribute_val); int PMPI_Comm_set_name(MPI_Comm comm, const char *comm_name); int PMPI_File_call_errhandler(MPI_File fh, int errorcode); int PMPI_Grequest_complete(MPI_Request request); int PMPI_Grequest_start(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, void *extra_state, MPI_Request *request); int PMPI_Init_thread(int *argc, char ***argv, int required, int *provided); int PMPI_Is_thread_main(int *flag); int PMPI_Query_thread(int *provided); int PMPI_Status_set_cancelled(MPI_Status *status, int flag); int PMPI_Status_set_elements(MPI_Status *status, MPI_Datatype datatype, int count); int PMPI_Type_create_keyval(MPI_Type_copy_attr_function *type_copy_attr_fn, MPI_Type_delete_attr_function *type_delete_attr_fn, int *type_keyval, void *extra_state); int PMPI_Type_delete_attr(MPI_Datatype datatype, int type_keyval); int PMPI_Type_dup(MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_free_keyval(int *type_keyval); int PMPI_Type_get_attr(MPI_Datatype datatype, int type_keyval, void *attribute_val, int *flag); int PMPI_Type_get_contents(MPI_Datatype datatype, int max_integers, int max_addresses, int max_datatypes, int array_of_integers[], MPI_Aint array_of_addresses[], MPI_Datatype array_of_datatypes[]); int PMPI_Type_get_envelope(MPI_Datatype datatype, int *num_integers, int *num_addresses, int *num_datatypes, int *combiner); int PMPI_Type_get_name(MPI_Datatype datatype, char *type_name, int *resultlen); int PMPI_Type_set_attr(MPI_Datatype datatype, int type_keyval, void *attribute_val); int PMPI_Type_set_name(MPI_Datatype datatype, const char *type_name); int PMPI_Type_match_size(int typeclass, int size, MPI_Datatype *datatype); int PMPI_Win_call_errhandler(MPI_Win win, int errorcode); int PMPI_Win_create_keyval(MPI_Win_copy_attr_function *win_copy_attr_fn, MPI_Win_delete_attr_function *win_delete_attr_fn, int *win_keyval, void *extra_state); int PMPI_Win_delete_attr(MPI_Win win, int win_keyval); int PMPI_Win_free_keyval(int *win_keyval); int PMPI_Win_get_attr(MPI_Win win, int win_keyval, void *attribute_val, int *flag); int PMPI_Win_get_name(MPI_Win win, char *win_name, int *resultlen); int PMPI_Win_set_attr(MPI_Win win, int win_keyval, void *attribute_val); int PMPI_Win_set_name(MPI_Win win, const char *win_name); int PMPI_Alloc_mem(MPI_Aint size, MPI_Info info, void *baseptr); int PMPI_Comm_create_errhandler(MPI_Comm_errhandler_function *comm_errhandler_fn, MPI_Errhandler *errhandler); int PMPI_Comm_get_errhandler(MPI_Comm comm, MPI_Errhandler *errhandler); int PMPI_Comm_set_errhandler(MPI_Comm comm, MPI_Errhandler errhandler); int PMPI_File_create_errhandler(MPI_File_errhandler_function *file_errhandler_fn, MPI_Errhandler *errhandler); int PMPI_File_get_errhandler(MPI_File file, MPI_Errhandler *errhandler); int PMPI_File_set_errhandler(MPI_File file, MPI_Errhandler errhandler); int PMPI_Finalized(int *flag); int PMPI_Free_mem(void *base); int PMPI_Get_address(const void *location, MPI_Aint *address); int PMPI_Info_create(MPI_Info *info); int PMPI_Info_delete(MPI_Info info, const char *key); int PMPI_Info_dup(MPI_Info info, MPI_Info *newinfo); int PMPI_Info_free(MPI_Info *info); int PMPI_Info_get(MPI_Info info, const char *key, int valuelen, char *value, int *flag); int PMPI_Info_get_nkeys(MPI_Info info, int *nkeys); int PMPI_Info_get_nthkey(MPI_Info info, int n, char *key); int PMPI_Info_get_valuelen(MPI_Info info, const char *key, int *valuelen, int *flag); int PMPI_Info_set(MPI_Info info, const char *key, const char *value); int PMPI_Pack_external(const char datarep[], const void *inbuf, int incount, MPI_Datatype datatype, void *outbuf, MPI_Aint outsize, MPI_Aint *position) ; int PMPI_Pack_external_size(const char datarep[], int incount, MPI_Datatype datatype, MPI_Aint *size); int PMPI_Request_get_status(MPI_Request request, int *flag, MPI_Status *status); int PMPI_Status_c2f(const MPI_Status *c_status, MPI_Fint *f_status); int PMPI_Status_f2c(const MPI_Fint *f_status, MPI_Status *c_status); int PMPI_Type_create_darray(int size, int rank, int ndims, const int array_of_gsizes[], const int array_of_distribs[], const int array_of_dargs[], const int array_of_psizes[], int order, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_create_hindexed(int count, const int array_of_blocklengths[], const MPI_Aint array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_create_hvector(int count, int blocklength, MPI_Aint stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_create_indexed_block(int count, int blocklength, const int array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_create_hindexed_block(int count, int blocklength, const MPI_Aint array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_create_resized(MPI_Datatype oldtype, MPI_Aint lb, MPI_Aint extent, MPI_Datatype *newtype); int PMPI_Type_create_struct(int count, const int array_of_blocklengths[], const MPI_Aint array_of_displacements[], const MPI_Datatype array_of_types[], MPI_Datatype *newtype); int PMPI_Type_create_subarray(int ndims, const int array_of_sizes[], const int array_of_subsizes[], const int array_of_starts[], int order, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_get_extent(MPI_Datatype datatype, MPI_Aint *lb, MPI_Aint *extent); int PMPI_Type_get_true_extent(MPI_Datatype datatype, MPI_Aint *true_lb, MPI_Aint *true_extent); int PMPI_Unpack_external(const char datarep[], const void *inbuf, MPI_Aint insize, MPI_Aint *position, void *outbuf, int outcount, MPI_Datatype datatype) ; int PMPI_Win_create_errhandler(MPI_Win_errhandler_function *win_errhandler_fn, MPI_Errhandler *errhandler); int PMPI_Win_get_errhandler(MPI_Win win, MPI_Errhandler *errhandler); int PMPI_Win_set_errhandler(MPI_Win win, MPI_Errhandler errhandler); int PMPI_Type_create_f90_integer(int r, MPI_Datatype *newtype); int PMPI_Type_create_f90_real(int p, int r, MPI_Datatype *newtype); int PMPI_Type_create_f90_complex(int p, int r, MPI_Datatype *newtype); int PMPI_Reduce_local(const void *inbuf, void *inoutbuf, int count, MPI_Datatype datatype, MPI_Op op) ; int PMPI_Op_commutative(MPI_Op op, int *commute); int PMPI_Reduce_scatter_block(const void *sendbuf, void *recvbuf, int recvcount, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int PMPI_Dist_graph_create_adjacent(MPI_Comm comm_old, int indegree, const int sources[], const int sourceweights[], int outdegree, const int destinations[], const int destweights[], MPI_Info info, int reorder, MPI_Comm *comm_dist_graph); int PMPI_Dist_graph_create(MPI_Comm comm_old, int n, const int sources[], const int degrees[], const int destinations[], const int weights[], MPI_Info info, int reorder, MPI_Comm *comm_dist_graph); int PMPI_Dist_graph_neighbors_count(MPI_Comm comm, int *indegree, int *outdegree, int *weighted); int PMPI_Dist_graph_neighbors(MPI_Comm comm, int maxindegree, int sources[], int sourceweights[], int maxoutdegree, int destinations[], int destweights[]); int PMPI_Improbe(int source, int tag, MPI_Comm comm, int *flag, MPI_Message *message, MPI_Status *status); int PMPI_Imrecv(void *buf, int count, MPI_Datatype datatype, MPI_Message *message, MPI_Request *request) ; int PMPI_Mprobe(int source, int tag, MPI_Comm comm, MPI_Message *message, MPI_Status *status); int PMPI_Mrecv(void *buf, int count, MPI_Datatype datatype, MPI_Message *message, MPI_Status *status) ; int PMPI_Comm_idup(MPI_Comm comm, MPI_Comm *newcomm, MPI_Request *request); int PMPI_Ibarrier(MPI_Comm comm, MPI_Request *request); int PMPI_Ibcast(void *buffer, int count, MPI_Datatype datatype, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Igather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Igatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iscatter(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iscatterv(const void *sendbuf, const int sendcounts[], const int displs[], MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iallgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iallgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ialltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ialltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ialltoallw(const void *sendbuf, const int sendcounts[], const int sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const int rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm, MPI_Request *request); int PMPI_Ireduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iallreduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ireduce_scatter(const void *sendbuf, void *recvbuf, const int recvcounts[], MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ireduce_scatter_block(const void *sendbuf, void *recvbuf, int recvcount, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iexscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ineighbor_allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ineighbor_allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ineighbor_alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ineighbor_alltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ineighbor_alltoallw(const void *sendbuf, const int sendcounts[], const MPI_Aint sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const MPI_Aint rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm, MPI_Request *request); int PMPI_Neighbor_allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Neighbor_allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Neighbor_alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Neighbor_alltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Neighbor_alltoallw(const void *sendbuf, const int sendcounts[], const MPI_Aint sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const MPI_Aint rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm); int PMPI_Comm_split_type(MPI_Comm comm, int split_type, int key, MPI_Info info, MPI_Comm *newcomm); int PMPI_Comm_create_group(MPI_Comm comm, MPI_Group group, int tag, MPI_Comm *newcomm); int PMPI_Get_elements_x(const MPI_Status *status, MPI_Datatype datatype, MPI_Count *count); int PMPI_Status_set_elements_x(MPI_Status *status, MPI_Datatype datatype, MPI_Count count); int PMPI_Type_get_extent_x(MPI_Datatype datatype, MPI_Count *lb, MPI_Count *extent); int PMPI_Type_get_true_extent_x(MPI_Datatype datatype, MPI_Count *lb, MPI_Count *extent); int PMPI_Type_size_x(MPI_Datatype datatype, MPI_Count *size); MPI_Aint PMPI_Aint_add(MPI_Aint base, MPI_Aint disp); MPI_Aint PMPI_Aint_diff(MPI_Aint addr1, MPI_Aint addr2); int PMPI_T_init_thread(int required, int *provided); int PMPI_T_finalize(void); int PMPI_T_enum_get_info(MPI_T_enum enumtype, int *num, char *name, int *name_len); int PMPI_T_enum_get_item(MPI_T_enum enumtype, int indx, int *value, char *name, int *name_len); int PMPI_T_cvar_get_num(int *num_cvar); int PMPI_T_cvar_get_info(int cvar_index, char *name, int *name_len, int *verbosity, MPI_Datatype *datatype, MPI_T_enum *enumtype, char *desc, int *desc_len, int *binding, int *scope); int PMPI_T_cvar_handle_alloc(int cvar_index, void *obj_handle, MPI_T_cvar_handle *handle, int *count); int PMPI_T_cvar_handle_free(MPI_T_cvar_handle *handle); int PMPI_T_cvar_read(MPI_T_cvar_handle handle, void *buf); int PMPI_T_cvar_write(MPI_T_cvar_handle handle, const void *buf); int PMPI_T_pvar_get_num(int *num_pvar); int PMPI_T_pvar_get_info(int pvar_index, char *name, int *name_len, int *verbosity, int *var_class, MPI_Datatype *datatype, MPI_T_enum *enumtype, char *desc, int *desc_len, int *binding, int *readonly, int *continuous, int *atomic); int PMPI_T_pvar_session_create(MPI_T_pvar_session *session); int PMPI_T_pvar_session_free(MPI_T_pvar_session *session); int PMPI_T_pvar_handle_alloc(MPI_T_pvar_session session, int pvar_index, void *obj_handle, MPI_T_pvar_handle *handle, int *count); int PMPI_T_pvar_handle_free(MPI_T_pvar_session session, MPI_T_pvar_handle *handle); int PMPI_T_pvar_start(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int PMPI_T_pvar_stop(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int PMPI_T_pvar_read(MPI_T_pvar_session session, MPI_T_pvar_handle handle, void *buf); int PMPI_T_pvar_write(MPI_T_pvar_session session, MPI_T_pvar_handle handle, const void *buf); int PMPI_T_pvar_reset(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int PMPI_T_pvar_readreset(MPI_T_pvar_session session, MPI_T_pvar_handle handle, void *buf); int PMPI_T_category_get_num(int *num_cat); int PMPI_T_category_get_info(int cat_index, char *name, int *name_len, char *desc, int *desc_len, int *num_cvars, int *num_pvars, int *num_categories); int PMPI_T_category_get_cvars(int cat_index, int len, int indices[]); int PMPI_T_category_get_pvars(int cat_index, int len, int indices[]); int PMPI_T_category_get_categories(int cat_index, int len, int indices[]); int PMPI_T_category_changed(int *stamp); int PMPI_T_cvar_get_index(const char *name, int *cvar_index); int PMPI_T_pvar_get_index(const char *name, int var_class, int *pvar_index); int PMPI_T_category_get_index(const char *name, int *cat_index); int PMPIX_Comm_failure_ack(MPI_Comm comm); int PMPIX_Comm_failure_get_acked(MPI_Comm comm, MPI_Group *failedgrp); int PMPIX_Comm_revoke(MPI_Comm comm); int PMPIX_Comm_shrink(MPI_Comm comm, MPI_Comm *newcomm); int PMPIX_Comm_agree(MPI_Comm comm, int *flag); #line 2340 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 1 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 1 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 80 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 99 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 106 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 123 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 140 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 150 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 160 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 182 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" int MPI_File_open(MPI_Comm comm, const char *filename, int amode, MPI_Info info, MPI_File *fh); int MPI_File_close(MPI_File *fh); int MPI_File_delete(const char *filename, MPI_Info info); int MPI_File_set_size(MPI_File fh, MPI_Offset size); int MPI_File_preallocate(MPI_File fh, MPI_Offset size); int MPI_File_get_size(MPI_File fh, MPI_Offset *size); int MPI_File_get_group(MPI_File fh, MPI_Group *group); int MPI_File_get_amode(MPI_File fh, int *amode); int MPI_File_set_info(MPI_File fh, MPI_Info info); int MPI_File_get_info(MPI_File fh, MPI_Info *info_used); int MPI_File_set_view(MPI_File fh, MPI_Offset disp, MPI_Datatype etype, MPI_Datatype filetype, const char *datarep, MPI_Info info); int MPI_File_get_view(MPI_File fh, MPI_Offset *disp, MPI_Datatype *etype, MPI_Datatype *filetype, char *datarep); int MPI_File_read_at(MPI_File fh, MPI_Offset offset, void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_read_at_all(MPI_File fh, MPI_Offset offset, void * buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write_at(MPI_File fh, MPI_Offset offset, const void * buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write_at_all(MPI_File fh, MPI_Offset offset, const void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_iread_at(MPI_File fh, MPI_Offset offset, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iwrite_at(MPI_File fh, MPI_Offset offset, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_read(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_read_all(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write_all(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_iread(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iwrite(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_seek(MPI_File fh, MPI_Offset offset, int whence); int MPI_File_get_position(MPI_File fh, MPI_Offset *offset); int MPI_File_get_byte_offset(MPI_File fh, MPI_Offset offset, MPI_Offset *disp); int MPI_File_read_shared(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write_shared(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_iread_shared(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iwrite_shared(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_read_ordered(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write_ordered(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_seek_shared(MPI_File fh, MPI_Offset offset, int whence); int MPI_File_get_position_shared(MPI_File fh, MPI_Offset *offset); int MPI_File_read_at_all_begin(MPI_File fh, MPI_Offset offset, void *buf, int count, MPI_Datatype datatype) ; int MPI_File_read_at_all_end(MPI_File fh, void *buf, MPI_Status *status); int MPI_File_write_at_all_begin(MPI_File fh, MPI_Offset offset, const void *buf, int count, MPI_Datatype datatype) ; int MPI_File_write_at_all_end(MPI_File fh, const void *buf, MPI_Status *status); int MPI_File_read_all_begin(MPI_File fh, void *buf, int count, MPI_Datatype datatype) ; int MPI_File_read_all_end(MPI_File fh, void *buf, MPI_Status *status); int MPI_File_write_all_begin(MPI_File fh, const void *buf, int count, MPI_Datatype datatype) ; int MPI_File_write_all_end(MPI_File fh, const void *buf, MPI_Status *status); int MPI_File_read_ordered_begin(MPI_File fh, void *buf, int count, MPI_Datatype datatype) ; int MPI_File_read_ordered_end(MPI_File fh, void *buf, MPI_Status *status); int MPI_File_write_ordered_begin(MPI_File fh, const void *buf, int count, MPI_Datatype datatype) ; int MPI_File_write_ordered_end(MPI_File fh, const void *buf, MPI_Status *status); int MPI_File_get_type_extent(MPI_File fh, MPI_Datatype datatype, MPI_Aint *extent); int MPI_Register_datarep(const char *datarep, MPI_Datarep_conversion_function *read_conversion_fn, MPI_Datarep_conversion_function *write_conversion_fn, MPI_Datarep_extent_function *dtype_file_extent_fn, void *extra_state); int MPI_File_set_atomicity(MPI_File fh, int flag); int MPI_File_get_atomicity(MPI_File fh, int *flag); int MPI_File_sync(MPI_File fh); int MPI_File_iread_at_all(MPI_File fh, MPI_Offset offset, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iwrite_at_all(MPI_File fh, MPI_Offset offset, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iread_all(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iwrite_all(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; #line 338 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 351 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" MPI_File MPI_File_f2c(MPI_Fint file); MPI_Fint MPI_File_c2f(MPI_File file); #line 376 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 405 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" int PMPI_File_open(MPI_Comm, const char *, int, MPI_Info, MPI_File *); int PMPI_File_close(MPI_File *); int PMPI_File_delete(const char *, MPI_Info); int PMPI_File_set_size(MPI_File, MPI_Offset); int PMPI_File_preallocate(MPI_File, MPI_Offset); int PMPI_File_get_size(MPI_File, MPI_Offset *); int PMPI_File_get_group(MPI_File, MPI_Group *); int PMPI_File_get_amode(MPI_File, int *); int PMPI_File_set_info(MPI_File, MPI_Info); int PMPI_File_get_info(MPI_File, MPI_Info *); int PMPI_File_set_view(MPI_File, MPI_Offset, MPI_Datatype, MPI_Datatype, const char *, MPI_Info); int PMPI_File_get_view(MPI_File, MPI_Offset *, MPI_Datatype *, MPI_Datatype *, char *); int PMPI_File_read_at(MPI_File, MPI_Offset, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_read_at_all(MPI_File, MPI_Offset, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write_at(MPI_File, MPI_Offset, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write_at_all(MPI_File, MPI_Offset, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_iread_at(MPI_File, MPI_Offset, void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_iwrite_at(MPI_File, MPI_Offset, const void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_read(MPI_File, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_read_all(MPI_File, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write(MPI_File, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write_all(MPI_File, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_iread(MPI_File, void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_iwrite(MPI_File, const void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_seek(MPI_File, MPI_Offset, int); int PMPI_File_get_position(MPI_File, MPI_Offset *); int PMPI_File_get_byte_offset(MPI_File, MPI_Offset, MPI_Offset *); int PMPI_File_read_shared(MPI_File, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write_shared(MPI_File, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_iread_shared(MPI_File, void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_iwrite_shared(MPI_File, const void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_read_ordered(MPI_File, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write_ordered(MPI_File, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_seek_shared(MPI_File, MPI_Offset, int); int PMPI_File_get_position_shared(MPI_File, MPI_Offset *); int PMPI_File_read_at_all_begin(MPI_File, MPI_Offset, void *, int, MPI_Datatype) ; int PMPI_File_read_at_all_end(MPI_File, void *, MPI_Status *); int PMPI_File_write_at_all_begin(MPI_File, MPI_Offset, const void *, int, MPI_Datatype) ; int PMPI_File_write_at_all_end(MPI_File, const void *, MPI_Status *); int PMPI_File_read_all_begin(MPI_File, void *, int, MPI_Datatype) ; int PMPI_File_read_all_end(MPI_File, void *, MPI_Status *); int PMPI_File_write_all_begin(MPI_File, const void *, int, MPI_Datatype) ; int PMPI_File_write_all_end(MPI_File, const void *, MPI_Status *); int PMPI_File_read_ordered_begin(MPI_File, void *, int, MPI_Datatype) ; int PMPI_File_read_ordered_end(MPI_File, void *, MPI_Status *); int PMPI_File_write_ordered_begin(MPI_File, const void *, int, MPI_Datatype) ; int PMPI_File_write_ordered_end(MPI_File, const void *, MPI_Status *); int PMPI_File_get_type_extent(MPI_File, MPI_Datatype, MPI_Aint *); int PMPI_Register_datarep(const char *, MPI_Datarep_conversion_function *, MPI_Datarep_conversion_function *, MPI_Datarep_extent_function *, void *); int PMPI_File_set_atomicity(MPI_File, int); int PMPI_File_get_atomicity(MPI_File, int *); int PMPI_File_sync(MPI_File); int PMPI_File_iread_at_all(MPI_File fh, MPI_Offset offset, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int PMPI_File_iwrite_at_all(MPI_File fh, MPI_Offset offset, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int PMPI_File_iread_all(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int PMPI_File_iwrite_all(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; #line 563 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" MPI_File PMPI_File_f2c(MPI_Fint); MPI_Fint PMPI_File_c2f(MPI_File); #line 583 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 600 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 2342 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 2360 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef int MPIX_Grequest_class; int MPIX_Grequest_class_create(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, MPIX_Grequest_poll_function *poll_fn, MPIX_Grequest_wait_function *wait_fn, MPIX_Grequest_class *greq_class); int MPIX_Grequest_class_allocate(MPIX_Grequest_class greq_class, void *extra_state, MPI_Request *request); int MPIX_Grequest_start(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, MPIX_Grequest_poll_function *poll_fn, MPIX_Grequest_wait_function *wait_fn, void *extra_state, MPI_Request *request); struct mpixi_mutex_s; typedef struct mpixi_mutex_s * MPIX_Mutex; int MPIX_Mutex_create(int count, MPI_Comm comm, MPIX_Mutex *hdl); int MPIX_Mutex_free(MPIX_Mutex *hdl); int MPIX_Mutex_lock(MPIX_Mutex hdl, int mutex, int proc); int MPIX_Mutex_unlock(MPIX_Mutex hdl, int mutex, int proc); int PMPIX_Grequest_class_create(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, MPIX_Grequest_poll_function *poll_fn, MPIX_Grequest_wait_function *wait_fn, MPIX_Grequest_class *greq_class); int PMPIX_Grequest_class_allocate(MPIX_Grequest_class greq_class, void *extra_state, MPI_Request *request); int PMPIX_Grequest_start(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, MPIX_Grequest_poll_function *poll_fn, MPIX_Grequest_wait_function *wait_fn, void *extra_state, MPI_Request *request); int PMPIX_Mutex_create(int count, MPI_Comm comm, MPIX_Mutex *hdl); int PMPIX_Mutex_free(MPIX_Mutex *hdl); int PMPIX_Mutex_lock(MPIX_Mutex hdl, int mutex, int proc); int PMPIX_Mutex_unlock(MPIX_Mutex hdl, int mutex, int proc); #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Found header files ['mpi.h'] in ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include'] Popping language C ================================================================================ TEST configureConversion from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:248) TESTING: configureConversion from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:248) Check for the functions which convert communicators between C and Fortran - Define HAVE_MPI_COMM_F2C and HAVE_MPI_COMM_C2F if they are present - Some older MPI 1 implementations are missing these All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { if (MPI_Comm_f2c((MPI_Fint)0)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPI_COMM_F2C" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { if (MPI_Comm_c2f(MPI_COMM_WORLD)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPI_COMM_C2F" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { MPI_Fint a; ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPI_FINT" to "1" ================================================================================ TEST checkMPICHorOpenMPI from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:462) TESTING: checkMPICHorOpenMPI from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:462) Determine if MPICH_NUMVERSION or OMPI_MAJOR_VERSION exist in mpi.h Used for consistency checking of MPI installation at compile time Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int mpich_ver = I_MPI_NUMVERSION; int main() { ; return 0; } Source: #include "confdefs.h" #include "conffix.h" #include int mpich_ver = I_MPI_NUMVERSION; Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.MPI\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.MPI\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.MPI\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.MPI\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.MPI\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.MPI\\conftest.c" #line 1 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 85 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 106 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 113 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 122 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 131 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 138 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 148 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 165 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef int MPI_Datatype; #line 190 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 211 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 230 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 264 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 273 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 288 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 301 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 311 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 322 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 338 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef int MPI_Comm; typedef int MPI_Group; typedef int MPI_Win; typedef struct ADIOI_FileD *MPI_File; typedef int MPI_Op; #line 393 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 414 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef enum MPIR_Win_flavor { MPI_WIN_FLAVOR_CREATE = 1, MPI_WIN_FLAVOR_ALLOCATE = 2, MPI_WIN_FLAVOR_DYNAMIC = 3, MPI_WIN_FLAVOR_SHARED = 4 } MPIR_Win_flavor_t; typedef enum MPIR_Win_model { MPI_WIN_SEPARATE = 1, MPI_WIN_UNIFIED = 2 } MPIR_Win_model_t; typedef enum MPIR_Topo_type { MPI_GRAPH=1, MPI_CART=2, MPI_DIST_GRAPH=3 } MPIR_Topo_type; typedef void (MPI_Handler_function) ( MPI_Comm *, int *, ... ); typedef int (MPI_Comm_copy_attr_function)(MPI_Comm, int, void *, void *, void *, int *); typedef int (MPI_Comm_delete_attr_function)(MPI_Comm, int, void *, void *); typedef int (MPI_Type_copy_attr_function)(MPI_Datatype, int, void *, void *, void *, int *); typedef int (MPI_Type_delete_attr_function)(MPI_Datatype, int, void *, void *); typedef int (MPI_Win_copy_attr_function)(MPI_Win, int, void *, void *, void *, int *); typedef int (MPI_Win_delete_attr_function)(MPI_Win, int, void *, void *); typedef void (MPI_Comm_errhandler_function)(MPI_Comm *, int *, ...); typedef void (MPI_File_errhandler_function)(MPI_File *, int *, ...); typedef void (MPI_Win_errhandler_function)(MPI_Win *, int *, ...); typedef MPI_Comm_errhandler_function MPI_Comm_errhandler_fn; typedef MPI_File_errhandler_function MPI_File_errhandler_fn; typedef MPI_Win_errhandler_function MPI_Win_errhandler_fn; typedef int MPI_Errhandler; #line 517 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef int MPI_Request; typedef int MPI_Message; typedef void (MPI_User_function) ( void *, void *, int *, MPI_Datatype * ); typedef int (MPI_Copy_function) ( MPI_Comm, int, void *, void *, void *, int * ); typedef int (MPI_Delete_function) ( MPI_Comm, int, void *, void * ); enum MPIR_Combiner_enum { MPI_COMBINER_NAMED = 1, MPI_COMBINER_DUP = 2, MPI_COMBINER_CONTIGUOUS = 3, MPI_COMBINER_VECTOR = 4, MPI_COMBINER_HVECTOR_INTEGER = 5, MPI_COMBINER_HVECTOR = 6, MPI_COMBINER_INDEXED = 7, MPI_COMBINER_HINDEXED_INTEGER = 8, MPI_COMBINER_HINDEXED = 9, MPI_COMBINER_INDEXED_BLOCK = 10, MPI_COMBINER_STRUCT_INTEGER = 11, MPI_COMBINER_STRUCT = 12, MPI_COMBINER_SUBARRAY = 13, MPI_COMBINER_DARRAY = 14, MPI_COMBINER_F90_REAL = 15, MPI_COMBINER_F90_COMPLEX = 16, MPI_COMBINER_F90_INTEGER = 17, MPI_COMBINER_RESIZED = 18, MPI_COMBINER_HINDEXED_BLOCK = 19 }; typedef int MPI_Info; #line 635 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 657 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef __int64 MPI_Aint; typedef int MPI_Fint; typedef long long MPI_Count; typedef __int64 MPI_Offset; typedef struct MPI_Status { int count_lo; int count_hi_and_cancelled; int MPI_SOURCE; int MPI_TAG; int MPI_ERROR; } MPI_Status; struct MPIR_T_enum_s; struct MPIR_T_cvar_handle_s; struct MPIR_T_pvar_handle_s; struct MPIR_T_pvar_session_s; typedef struct MPIR_T_enum_s * MPI_T_enum; typedef struct MPIR_T_cvar_handle_s * MPI_T_cvar_handle; typedef struct MPIR_T_pvar_handle_s * MPI_T_pvar_handle; typedef struct MPIR_T_pvar_session_s * MPI_T_pvar_session; extern struct MPIR_T_pvar_handle_s * const MPI_T_PVAR_ALL_HANDLES; typedef enum MPIR_T_verbosity_t { MPIX_T_VERBOSITY_INVALID = 0, MPI_T_VERBOSITY_USER_BASIC = 221, MPI_T_VERBOSITY_USER_DETAIL, MPI_T_VERBOSITY_USER_ALL, MPI_T_VERBOSITY_TUNER_BASIC, MPI_T_VERBOSITY_TUNER_DETAIL, MPI_T_VERBOSITY_TUNER_ALL, MPI_T_VERBOSITY_MPIDEV_BASIC, MPI_T_VERBOSITY_MPIDEV_DETAIL, MPI_T_VERBOSITY_MPIDEV_ALL } MPIR_T_verbosity_t; typedef enum MPIR_T_bind_t { MPIX_T_BIND_INVALID = 0, MPI_T_BIND_NO_OBJECT = 9700, MPI_T_BIND_MPI_COMM, MPI_T_BIND_MPI_DATATYPE, MPI_T_BIND_MPI_ERRHANDLER, MPI_T_BIND_MPI_FILE, MPI_T_BIND_MPI_GROUP, MPI_T_BIND_MPI_OP, MPI_T_BIND_MPI_REQUEST, MPI_T_BIND_MPI_WIN, MPI_T_BIND_MPI_MESSAGE, MPI_T_BIND_MPI_INFO } MPIR_T_bind_t; typedef enum MPIR_T_scope_t { MPIX_T_SCOPE_INVALID = 0, MPI_T_SCOPE_CONSTANT = 60438, MPI_T_SCOPE_READONLY, MPI_T_SCOPE_LOCAL, MPI_T_SCOPE_GROUP, MPI_T_SCOPE_GROUP_EQ, MPI_T_SCOPE_ALL, MPI_T_SCOPE_ALL_EQ } MPIR_T_scope_t; typedef enum MPIR_T_pvar_class_t { MPIX_T_PVAR_CLASS_INVALID = 0, MPIR_T_PVAR_CLASS_FIRST = 240, MPI_T_PVAR_CLASS_STATE = MPIR_T_PVAR_CLASS_FIRST, MPI_T_PVAR_CLASS_LEVEL, MPI_T_PVAR_CLASS_SIZE, MPI_T_PVAR_CLASS_PERCENTAGE, MPI_T_PVAR_CLASS_HIGHWATERMARK, MPI_T_PVAR_CLASS_LOWWATERMARK, MPI_T_PVAR_CLASS_COUNTER, MPI_T_PVAR_CLASS_AGGREGATE, MPI_T_PVAR_CLASS_TIMER, MPI_T_PVAR_CLASS_GENERIC, MPIR_T_PVAR_CLASS_LAST, MPIR_T_PVAR_CLASS_NUMBER = MPIR_T_PVAR_CLASS_LAST - MPIR_T_PVAR_CLASS_FIRST } MPIR_T_pvar_class_t; #line 814 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 834 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 850 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" extern __declspec(dllimport) MPI_Fint * MPI_F_STATUS_IGNORE; extern __declspec(dllimport) MPI_Fint * MPI_F_STATUSES_IGNORE; extern __declspec(dllimport) int * const MPI_UNWEIGHTED; extern __declspec(dllimport) int * const MPI_WEIGHTS_EMPTY; typedef struct { MPI_Fint count_lo; MPI_Fint count_hi_and_cancelled; MPI_Fint MPI_SOURCE; MPI_Fint MPI_TAG; MPI_Fint MPI_ERROR; } MPI_F08_Status; extern MPI_F08_Status MPIR_F08_MPI_STATUS_IGNORE_OBJ; extern MPI_F08_Status MPIR_F08_MPI_STATUSES_IGNORE_OBJ[1]; extern int MPIR_F08_MPI_IN_PLACE; extern int MPIR_F08_MPI_BOTTOM; extern MPI_F08_Status *MPI_F08_STATUS_IGNORE; extern MPI_F08_Status *MPI_F08_STATUSES_IGNORE; typedef int (MPI_Grequest_cancel_function)(void *, int); typedef int (MPI_Grequest_free_function)(void *); typedef int (MPI_Grequest_query_function)(void *, MPI_Status *); typedef int (MPIX_Grequest_poll_function)(void *, MPI_Status *); typedef int (MPIX_Grequest_wait_function)(int, void **, double, MPI_Status *); #line 909 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 946 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 963 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 972 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 998 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef int (MPI_Datarep_conversion_function)(void *, MPI_Datatype, int, void *, MPI_Offset, void *); typedef int (MPI_Datarep_extent_function)(MPI_Datatype datatype, MPI_Aint *, void *); int MPI_Send(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int MPI_Recv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Status *status) ; int MPI_Get_count(const MPI_Status *status, MPI_Datatype datatype, int *count); int MPI_Bsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int MPI_Ssend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int MPI_Rsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int MPI_Buffer_attach(void *buffer, int size); int MPI_Buffer_detach(void *buffer_addr, int *size); int MPI_Isend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Ibsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Issend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Irsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Irecv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Wait(MPI_Request *request, MPI_Status *status); int MPI_Test(MPI_Request *request, int *flag, MPI_Status *status); int MPI_Request_free(MPI_Request *request); int MPI_Waitany(int count, MPI_Request array_of_requests[], int *indx, MPI_Status *status); int MPI_Testany(int count, MPI_Request array_of_requests[], int *indx, int *flag, MPI_Status *status); int MPI_Waitall(int count, MPI_Request array_of_requests[], MPI_Status array_of_statuses[]); int MPI_Testall(int count, MPI_Request array_of_requests[], int *flag, MPI_Status array_of_statuses[]); int MPI_Waitsome(int incount, MPI_Request array_of_requests[], int *outcount, int array_of_indices[], MPI_Status array_of_statuses[]); int MPI_Testsome(int incount, MPI_Request array_of_requests[], int *outcount, int array_of_indices[], MPI_Status array_of_statuses[]); int MPI_Iprobe(int source, int tag, MPI_Comm comm, int *flag, MPI_Status *status); int MPI_Probe(int source, int tag, MPI_Comm comm, MPI_Status *status); int MPI_Cancel(MPI_Request *request); int MPI_Test_cancelled(const MPI_Status *status, int *flag); int MPI_Send_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Bsend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Ssend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Rsend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Recv_init(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Request *request) ; int MPI_Start(MPI_Request *request); int MPI_Startall(int count, MPI_Request array_of_requests[]); int MPI_Sendrecv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, int dest, int sendtag, void *recvbuf, int recvcount, MPI_Datatype recvtype, int source, int recvtag, MPI_Comm comm, MPI_Status *status) ; int MPI_Sendrecv_replace(void *buf, int count, MPI_Datatype datatype, int dest, int sendtag, int source, int recvtag, MPI_Comm comm, MPI_Status *status) ; int MPI_Type_contiguous(int count, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_vector(int count, int blocklength, int stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_hvector(int count, int blocklength, MPI_Aint stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_indexed(int count, const int *array_of_blocklengths, const int *array_of_displacements, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_hindexed(int count, const int *array_of_blocklengths, const MPI_Aint *array_of_displacements, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_struct(int count, const int *array_of_blocklengths, const MPI_Aint *array_of_displacements, const MPI_Datatype *array_of_types, MPI_Datatype *newtype); int MPI_Address(const void *location, MPI_Aint *address); int MPI_Type_extent(MPI_Datatype datatype, MPI_Aint *extent); int MPI_Type_size(MPI_Datatype datatype, int *size); int MPI_Type_lb(MPI_Datatype datatype, MPI_Aint *displacement); int MPI_Type_ub(MPI_Datatype datatype, MPI_Aint *displacement); int MPI_Type_commit(MPI_Datatype *datatype); int MPI_Type_free(MPI_Datatype *datatype); int MPI_Get_elements(const MPI_Status *status, MPI_Datatype datatype, int *count); int MPI_Pack(const void *inbuf, int incount, MPI_Datatype datatype, void *outbuf, int outsize, int *position, MPI_Comm comm) ; int MPI_Unpack(const void *inbuf, int insize, int *position, void *outbuf, int outcount, MPI_Datatype datatype, MPI_Comm comm) ; int MPI_Pack_size(int incount, MPI_Datatype datatype, MPI_Comm comm, int *size); int MPI_Barrier(MPI_Comm comm); int MPI_Bcast(void *buffer, int count, MPI_Datatype datatype, int root, MPI_Comm comm) ; int MPI_Gather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int MPI_Gatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *displs, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int MPI_Scatter(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int MPI_Scatterv(const void *sendbuf, const int *sendcounts, const int *displs, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int MPI_Allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *displs, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Alltoallv(const void *sendbuf, const int *sendcounts, const int *sdispls, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *rdispls, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Alltoallw(const void *sendbuf, const int sendcounts[], const int sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const int rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm); int MPI_Exscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int MPI_Reduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, int root, MPI_Comm comm) ; int MPI_Op_create(MPI_User_function *user_fn, int commute, MPI_Op *op); int MPI_Op_free(MPI_Op *op); int MPI_Allreduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int MPI_Reduce_scatter(const void *sendbuf, void *recvbuf, const int recvcounts[], MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int MPI_Scan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int MPI_Group_size(MPI_Group group, int *size); int MPI_Group_rank(MPI_Group group, int *rank); int MPI_Group_translate_ranks(MPI_Group group1, int n, const int ranks1[], MPI_Group group2, int ranks2[]); int MPI_Group_compare(MPI_Group group1, MPI_Group group2, int *result); int MPI_Comm_group(MPI_Comm comm, MPI_Group *group); int MPI_Group_union(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int MPI_Group_intersection(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int MPI_Group_difference(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int MPI_Group_incl(MPI_Group group, int n, const int ranks[], MPI_Group *newgroup); int MPI_Group_excl(MPI_Group group, int n, const int ranks[], MPI_Group *newgroup); int MPI_Group_range_incl(MPI_Group group, int n, int ranges[][3], MPI_Group *newgroup); int MPI_Group_range_excl(MPI_Group group, int n, int ranges[][3], MPI_Group *newgroup); int MPI_Group_free(MPI_Group *group); int MPI_Comm_size(MPI_Comm comm, int *size); int MPI_Comm_rank(MPI_Comm comm, int *rank); int MPI_Comm_compare(MPI_Comm comm1, MPI_Comm comm2, int *result); int MPI_Comm_dup(MPI_Comm comm, MPI_Comm *newcomm); int MPI_Comm_dup_with_info(MPI_Comm comm, MPI_Info info, MPI_Comm *newcomm); int MPI_Comm_create(MPI_Comm comm, MPI_Group group, MPI_Comm *newcomm); int MPI_Comm_split(MPI_Comm comm, int color, int key, MPI_Comm *newcomm); int MPI_Comm_free(MPI_Comm *comm); int MPI_Comm_test_inter(MPI_Comm comm, int *flag); int MPI_Comm_remote_size(MPI_Comm comm, int *size); int MPI_Comm_remote_group(MPI_Comm comm, MPI_Group *group); int MPI_Intercomm_create(MPI_Comm local_comm, int local_leader, MPI_Comm peer_comm, int remote_leader, int tag, MPI_Comm *newintercomm); int MPI_Intercomm_merge(MPI_Comm intercomm, int high, MPI_Comm *newintracomm); int MPI_Keyval_create(MPI_Copy_function *copy_fn, MPI_Delete_function *delete_fn, int *keyval, void *extra_state); int MPI_Keyval_free(int *keyval); int MPI_Attr_put(MPI_Comm comm, int keyval, void *attribute_val); int MPI_Attr_get(MPI_Comm comm, int keyval, void *attribute_val, int *flag); int MPI_Attr_delete(MPI_Comm comm, int keyval); int MPI_Topo_test(MPI_Comm comm, int *status); int MPI_Cart_create(MPI_Comm comm_old, int ndims, const int dims[], const int periods[], int reorder, MPI_Comm *comm_cart); int MPI_Dims_create(int nnodes, int ndims, int dims[]); int MPI_Graph_create(MPI_Comm comm_old, int nnodes, const int indx[], const int edges[], int reorder, MPI_Comm *comm_graph); int MPI_Graphdims_get(MPI_Comm comm, int *nnodes, int *nedges); int MPI_Graph_get(MPI_Comm comm, int maxindex, int maxedges, int indx[], int edges[]); int MPI_Cartdim_get(MPI_Comm comm, int *ndims); int MPI_Cart_get(MPI_Comm comm, int maxdims, int dims[], int periods[], int coords[]); int MPI_Cart_rank(MPI_Comm comm, const int coords[], int *rank); int MPI_Cart_coords(MPI_Comm comm, int rank, int maxdims, int coords[]); int MPI_Graph_neighbors_count(MPI_Comm comm, int rank, int *nneighbors); int MPI_Graph_neighbors(MPI_Comm comm, int rank, int maxneighbors, int neighbors[]); int MPI_Cart_shift(MPI_Comm comm, int direction, int disp, int *rank_source, int *rank_dest); int MPI_Cart_sub(MPI_Comm comm, const int remain_dims[], MPI_Comm *newcomm); int MPI_Cart_map(MPI_Comm comm, int ndims, const int dims[], const int periods[], int *newrank); int MPI_Graph_map(MPI_Comm comm, int nnodes, const int indx[], const int edges[], int *newrank); int MPI_Get_processor_name(char *name, int *resultlen); int MPI_Get_version(int *version, int *subversion); int MPI_Get_library_version(char *version, int *resultlen); int MPI_Errhandler_create(MPI_Handler_function *function, MPI_Errhandler *errhandler); int MPI_Errhandler_set(MPI_Comm comm, MPI_Errhandler errhandler); int MPI_Errhandler_get(MPI_Comm comm, MPI_Errhandler *errhandler); int MPI_Errhandler_free(MPI_Errhandler *errhandler); int MPI_Error_string(int errorcode, char *string, int *resultlen); int MPI_Error_class(int errorcode, int *errorclass); double MPI_Wtime(void); double MPI_Wtick(void); int MPI_Init(int *argc, char ***argv); int MPI_Finalize(void); int MPI_Initialized(int *flag); int MPI_Abort(MPI_Comm comm, int errorcode); int MPI_Pcontrol(const int level, ...); int MPIR_Dup_fn(MPI_Comm oldcomm, int keyval, void *extra_state, void *attribute_val_in, void *attribute_val_out, int *flag); int MPI_Close_port(const char *port_name); int MPI_Comm_accept(const char *port_name, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *newcomm); int MPI_Comm_connect(const char *port_name, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *newcomm); int MPI_Comm_disconnect(MPI_Comm *comm); int MPI_Comm_get_parent(MPI_Comm *parent); int MPI_Comm_join(int fd, MPI_Comm *intercomm); int MPI_Comm_spawn(const char *command, char *argv[], int maxprocs, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *intercomm, int array_of_errcodes[]); int MPI_Comm_spawn_multiple(int count, char *array_of_commands[], char **array_of_argv[], const int array_of_maxprocs[], const MPI_Info array_of_info[], int root, MPI_Comm comm, MPI_Comm *intercomm, int array_of_errcodes[]); int MPI_Lookup_name(const char *service_name, MPI_Info info, char *port_name); int MPI_Open_port(MPI_Info info, char *port_name); int MPI_Publish_name(const char *service_name, MPI_Info info, const char *port_name); int MPI_Unpublish_name(const char *service_name, MPI_Info info, const char *port_name); int MPI_Comm_set_info(MPI_Comm comm, MPI_Info info); int MPI_Comm_get_info(MPI_Comm comm, MPI_Info *info); int MPI_Accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win) ; int MPI_Get(void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win) ; int MPI_Put(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win) ; int MPI_Win_complete(MPI_Win win); int MPI_Win_create(void *base, MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, MPI_Win *win); int MPI_Win_fence(int assert, MPI_Win win); int MPI_Win_free(MPI_Win *win); int MPI_Win_get_group(MPI_Win win, MPI_Group *group); int MPI_Win_lock(int lock_type, int rank, int assert, MPI_Win win); int MPI_Win_post(MPI_Group group, int assert, MPI_Win win); int MPI_Win_start(MPI_Group group, int assert, MPI_Win win); int MPI_Win_test(MPI_Win win, int *flag); int MPI_Win_unlock(int rank, MPI_Win win); int MPI_Win_wait(MPI_Win win); int MPI_Win_allocate(MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, void *baseptr, MPI_Win *win); int MPI_Win_allocate_shared(MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, void *baseptr, MPI_Win *win); int MPI_Win_shared_query(MPI_Win win, int rank, MPI_Aint *size, int *disp_unit, void *baseptr); int MPI_Win_create_dynamic(MPI_Info info, MPI_Comm comm, MPI_Win *win); int MPI_Win_attach(MPI_Win win, void *base, MPI_Aint size); int MPI_Win_detach(MPI_Win win, const void *base); int MPI_Win_get_info(MPI_Win win, MPI_Info *info_used); int MPI_Win_set_info(MPI_Win win, MPI_Info info); int MPI_Get_accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, void *result_addr, int result_count, MPI_Datatype result_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win) ; int MPI_Fetch_and_op(const void *origin_addr, void *result_addr, MPI_Datatype datatype, int target_rank, MPI_Aint target_disp, MPI_Op op, MPI_Win win) ; int MPI_Compare_and_swap(const void *origin_addr, const void *compare_addr, void *result_addr, MPI_Datatype datatype, int target_rank, MPI_Aint target_disp, MPI_Win win) ; int MPI_Rput(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win, MPI_Request *request) ; int MPI_Rget(void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win, MPI_Request *request) ; int MPI_Raccumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win, MPI_Request *request) ; int MPI_Rget_accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, void *result_addr, int result_count, MPI_Datatype result_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win, MPI_Request *request) ; int MPI_Win_lock_all(int assert, MPI_Win win); int MPI_Win_unlock_all(MPI_Win win); int MPI_Win_flush(int rank, MPI_Win win); int MPI_Win_flush_all(MPI_Win win); int MPI_Win_flush_local(int rank, MPI_Win win); int MPI_Win_flush_local_all(MPI_Win win); int MPI_Win_sync(MPI_Win win); int MPI_Add_error_class(int *errorclass); int MPI_Add_error_code(int errorclass, int *errorcode); int MPI_Add_error_string(int errorcode, const char *string); int MPI_Comm_call_errhandler(MPI_Comm comm, int errorcode); int MPI_Comm_create_keyval(MPI_Comm_copy_attr_function *comm_copy_attr_fn, MPI_Comm_delete_attr_function *comm_delete_attr_fn, int *comm_keyval, void *extra_state); int MPI_Comm_delete_attr(MPI_Comm comm, int comm_keyval); int MPI_Comm_free_keyval(int *comm_keyval); int MPI_Comm_get_attr(MPI_Comm comm, int comm_keyval, void *attribute_val, int *flag); int MPI_Comm_get_name(MPI_Comm comm, char *comm_name, int *resultlen); int MPI_Comm_set_attr(MPI_Comm comm, int comm_keyval, void *attribute_val); int MPI_Comm_set_name(MPI_Comm comm, const char *comm_name); int MPI_File_call_errhandler(MPI_File fh, int errorcode); int MPI_Grequest_complete(MPI_Request request); int MPI_Grequest_start(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, void *extra_state, MPI_Request *request); int MPI_Init_thread(int *argc, char ***argv, int required, int *provided); int MPI_Is_thread_main(int *flag); int MPI_Query_thread(int *provided); int MPI_Status_set_cancelled(MPI_Status *status, int flag); int MPI_Status_set_elements(MPI_Status *status, MPI_Datatype datatype, int count); int MPI_Type_create_keyval(MPI_Type_copy_attr_function *type_copy_attr_fn, MPI_Type_delete_attr_function *type_delete_attr_fn, int *type_keyval, void *extra_state); int MPI_Type_delete_attr(MPI_Datatype datatype, int type_keyval); int MPI_Type_dup(MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_free_keyval(int *type_keyval); int MPI_Type_get_attr(MPI_Datatype datatype, int type_keyval, void *attribute_val, int *flag); int MPI_Type_get_contents(MPI_Datatype datatype, int max_integers, int max_addresses, int max_datatypes, int array_of_integers[], MPI_Aint array_of_addresses[], MPI_Datatype array_of_datatypes[]); int MPI_Type_get_envelope(MPI_Datatype datatype, int *num_integers, int *num_addresses, int *num_datatypes, int *combiner); int MPI_Type_get_name(MPI_Datatype datatype, char *type_name, int *resultlen); int MPI_Type_set_attr(MPI_Datatype datatype, int type_keyval, void *attribute_val); int MPI_Type_set_name(MPI_Datatype datatype, const char *type_name); int MPI_Type_match_size(int typeclass, int size, MPI_Datatype *datatype); int MPI_Win_call_errhandler(MPI_Win win, int errorcode); int MPI_Win_create_keyval(MPI_Win_copy_attr_function *win_copy_attr_fn, MPI_Win_delete_attr_function *win_delete_attr_fn, int *win_keyval, void *extra_state); int MPI_Win_delete_attr(MPI_Win win, int win_keyval); int MPI_Win_free_keyval(int *win_keyval); int MPI_Win_get_attr(MPI_Win win, int win_keyval, void *attribute_val, int *flag); int MPI_Win_get_name(MPI_Win win, char *win_name, int *resultlen); int MPI_Win_set_attr(MPI_Win win, int win_keyval, void *attribute_val); int MPI_Win_set_name(MPI_Win win, const char *win_name); int MPI_Alloc_mem(MPI_Aint size, MPI_Info info, void *baseptr); int MPI_Comm_create_errhandler(MPI_Comm_errhandler_function *comm_errhandler_fn, MPI_Errhandler *errhandler); int MPI_Comm_get_errhandler(MPI_Comm comm, MPI_Errhandler *errhandler); int MPI_Comm_set_errhandler(MPI_Comm comm, MPI_Errhandler errhandler); int MPI_File_create_errhandler(MPI_File_errhandler_function *file_errhandler_fn, MPI_Errhandler *errhandler); int MPI_File_get_errhandler(MPI_File file, MPI_Errhandler *errhandler); int MPI_File_set_errhandler(MPI_File file, MPI_Errhandler errhandler); int MPI_Finalized(int *flag); int MPI_Free_mem(void *base); int MPI_Get_address(const void *location, MPI_Aint *address); int MPI_Info_create(MPI_Info *info); int MPI_Info_delete(MPI_Info info, const char *key); int MPI_Info_dup(MPI_Info info, MPI_Info *newinfo); int MPI_Info_free(MPI_Info *info); int MPI_Info_get(MPI_Info info, const char *key, int valuelen, char *value, int *flag); int MPI_Info_get_nkeys(MPI_Info info, int *nkeys); int MPI_Info_get_nthkey(MPI_Info info, int n, char *key); int MPI_Info_get_valuelen(MPI_Info info, const char *key, int *valuelen, int *flag); int MPI_Info_set(MPI_Info info, const char *key, const char *value); int MPI_Pack_external(const char datarep[], const void *inbuf, int incount, MPI_Datatype datatype, void *outbuf, MPI_Aint outsize, MPI_Aint *position) ; int MPI_Pack_external_size(const char datarep[], int incount, MPI_Datatype datatype, MPI_Aint *size); int MPI_Request_get_status(MPI_Request request, int *flag, MPI_Status *status); int MPI_Status_c2f(const MPI_Status *c_status, MPI_Fint *f_status); int MPI_Status_f2c(const MPI_Fint *f_status, MPI_Status *c_status); int MPI_Type_create_darray(int size, int rank, int ndims, const int array_of_gsizes[], const int array_of_distribs[], const int array_of_dargs[], const int array_of_psizes[], int order, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_create_hindexed(int count, const int array_of_blocklengths[], const MPI_Aint array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_create_hvector(int count, int blocklength, MPI_Aint stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_create_indexed_block(int count, int blocklength, const int array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_create_hindexed_block(int count, int blocklength, const MPI_Aint array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_create_resized(MPI_Datatype oldtype, MPI_Aint lb, MPI_Aint extent, MPI_Datatype *newtype); int MPI_Type_create_struct(int count, const int array_of_blocklengths[], const MPI_Aint array_of_displacements[], const MPI_Datatype array_of_types[], MPI_Datatype *newtype); int MPI_Type_create_subarray(int ndims, const int array_of_sizes[], const int array_of_subsizes[], const int array_of_starts[], int order, MPI_Datatype oldtype, MPI_Datatype *newtype); int MPI_Type_get_extent(MPI_Datatype datatype, MPI_Aint *lb, MPI_Aint *extent); int MPI_Type_get_true_extent(MPI_Datatype datatype, MPI_Aint *true_lb, MPI_Aint *true_extent); int MPI_Unpack_external(const char datarep[], const void *inbuf, MPI_Aint insize, MPI_Aint *position, void *outbuf, int outcount, MPI_Datatype datatype) ; int MPI_Win_create_errhandler(MPI_Win_errhandler_function *win_errhandler_fn, MPI_Errhandler *errhandler); int MPI_Win_get_errhandler(MPI_Win win, MPI_Errhandler *errhandler); int MPI_Win_set_errhandler(MPI_Win win, MPI_Errhandler errhandler); int MPI_Type_create_f90_integer(int range, MPI_Datatype *newtype); int MPI_Type_create_f90_real(int precision, int range, MPI_Datatype *newtype); int MPI_Type_create_f90_complex(int precision, int range, MPI_Datatype *newtype); int MPI_Reduce_local(const void *inbuf, void *inoutbuf, int count, MPI_Datatype datatype, MPI_Op op) ; int MPI_Op_commutative(MPI_Op op, int *commute); int MPI_Reduce_scatter_block(const void *sendbuf, void *recvbuf, int recvcount, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int MPI_Dist_graph_create_adjacent(MPI_Comm comm_old, int indegree, const int sources[], const int sourceweights[], int outdegree, const int destinations[], const int destweights[], MPI_Info info, int reorder, MPI_Comm *comm_dist_graph); int MPI_Dist_graph_create(MPI_Comm comm_old, int n, const int sources[], const int degrees[], const int destinations[], const int weights[], MPI_Info info, int reorder, MPI_Comm *comm_dist_graph); int MPI_Dist_graph_neighbors_count(MPI_Comm comm, int *indegree, int *outdegree, int *weighted); int MPI_Dist_graph_neighbors(MPI_Comm comm, int maxindegree, int sources[], int sourceweights[], int maxoutdegree, int destinations[], int destweights[]); int MPI_Improbe(int source, int tag, MPI_Comm comm, int *flag, MPI_Message *message, MPI_Status *status); int MPI_Imrecv(void *buf, int count, MPI_Datatype datatype, MPI_Message *message, MPI_Request *request) ; int MPI_Mprobe(int source, int tag, MPI_Comm comm, MPI_Message *message, MPI_Status *status); int MPI_Mrecv(void *buf, int count, MPI_Datatype datatype, MPI_Message *message, MPI_Status *status) ; int MPI_Comm_idup(MPI_Comm comm, MPI_Comm *newcomm, MPI_Request *request); int MPI_Ibarrier(MPI_Comm comm, MPI_Request *request); int MPI_Ibcast(void *buffer, int count, MPI_Datatype datatype, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Igather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Igatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Iscatter(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Iscatterv(const void *sendbuf, const int sendcounts[], const int displs[], MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Iallgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Iallgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ialltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ialltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ialltoallw(const void *sendbuf, const int sendcounts[], const int sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const int rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm, MPI_Request *request); int MPI_Ireduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, int root, MPI_Comm comm, MPI_Request *request) ; int MPI_Iallreduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int MPI_Ireduce_scatter(const void *sendbuf, void *recvbuf, const int recvcounts[], MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int MPI_Ireduce_scatter_block(const void *sendbuf, void *recvbuf, int recvcount, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int MPI_Iscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int MPI_Iexscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int MPI_Ineighbor_allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ineighbor_allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ineighbor_alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ineighbor_alltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int MPI_Ineighbor_alltoallw(const void *sendbuf, const int sendcounts[], const MPI_Aint sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const MPI_Aint rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm, MPI_Request *request); int MPI_Neighbor_allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Neighbor_allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Neighbor_alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Neighbor_alltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm) ; int MPI_Neighbor_alltoallw(const void *sendbuf, const int sendcounts[], const MPI_Aint sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const MPI_Aint rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm); int MPI_Comm_split_type(MPI_Comm comm, int split_type, int key, MPI_Info info, MPI_Comm *newcomm); int MPI_Get_elements_x(const MPI_Status *status, MPI_Datatype datatype, MPI_Count *count); int MPI_Status_set_elements_x(MPI_Status *status, MPI_Datatype datatype, MPI_Count count); int MPI_Type_get_extent_x(MPI_Datatype datatype, MPI_Count *lb, MPI_Count *extent); int MPI_Type_get_true_extent_x(MPI_Datatype datatype, MPI_Count *lb, MPI_Count *extent); int MPI_Type_size_x(MPI_Datatype datatype, MPI_Count *size); int MPI_Comm_create_group(MPI_Comm comm, MPI_Group group, int tag, MPI_Comm *newcomm); MPI_Aint MPI_Aint_add(MPI_Aint base, MPI_Aint disp); MPI_Aint MPI_Aint_diff(MPI_Aint addr1, MPI_Aint addr2); int MPI_T_init_thread(int required, int *provided); int MPI_T_finalize(void); int MPI_T_enum_get_info(MPI_T_enum enumtype, int *num, char *name, int *name_len); int MPI_T_enum_get_item(MPI_T_enum enumtype, int indx, int *value, char *name, int *name_len); int MPI_T_cvar_get_num(int *num_cvar); int MPI_T_cvar_get_info(int cvar_index, char *name, int *name_len, int *verbosity, MPI_Datatype *datatype, MPI_T_enum *enumtype, char *desc, int *desc_len, int *binding, int *scope); int MPI_T_cvar_handle_alloc(int cvar_index, void *obj_handle, MPI_T_cvar_handle *handle, int *count); int MPI_T_cvar_handle_free(MPI_T_cvar_handle *handle); int MPI_T_cvar_read(MPI_T_cvar_handle handle, void *buf); int MPI_T_cvar_write(MPI_T_cvar_handle handle, const void *buf); int MPI_T_pvar_get_num(int *num_pvar); int MPI_T_pvar_get_info(int pvar_index, char *name, int *name_len, int *verbosity, int *var_class, MPI_Datatype *datatype, MPI_T_enum *enumtype, char *desc, int *desc_len, int *binding, int *readonly, int *continuous, int *atomic); int MPI_T_pvar_session_create(MPI_T_pvar_session *session); int MPI_T_pvar_session_free(MPI_T_pvar_session *session); int MPI_T_pvar_handle_alloc(MPI_T_pvar_session session, int pvar_index, void *obj_handle, MPI_T_pvar_handle *handle, int *count); int MPI_T_pvar_handle_free(MPI_T_pvar_session session, MPI_T_pvar_handle *handle); int MPI_T_pvar_start(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int MPI_T_pvar_stop(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int MPI_T_pvar_read(MPI_T_pvar_session session, MPI_T_pvar_handle handle, void *buf); int MPI_T_pvar_write(MPI_T_pvar_session session, MPI_T_pvar_handle handle, const void *buf); int MPI_T_pvar_reset(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int MPI_T_pvar_readreset(MPI_T_pvar_session session, MPI_T_pvar_handle handle, void *buf); int MPI_T_category_get_num(int *num_cat); int MPI_T_category_get_info(int cat_index, char *name, int *name_len, char *desc, int *desc_len, int *num_cvars, int *num_pvars, int *num_categories); int MPI_T_category_get_cvars(int cat_index, int len, int indices[]); int MPI_T_category_get_pvars(int cat_index, int len, int indices[]); int MPI_T_category_get_categories(int cat_index, int len, int indices[]); int MPI_T_category_changed(int *stamp); int MPI_T_cvar_get_index(const char *name, int *cvar_index); int MPI_T_pvar_get_index(const char *name, int var_class, int *pvar_index); int MPI_T_category_get_index(const char *name, int *cat_index); int MPIX_Comm_failure_ack(MPI_Comm comm); int MPIX_Comm_failure_get_acked(MPI_Comm comm, MPI_Group *failedgrp); int MPIX_Comm_revoke(MPI_Comm comm); int MPIX_Comm_shrink(MPI_Comm comm, MPI_Comm *newcomm); int MPIX_Comm_agree(MPI_Comm comm, int *flag); int PMPI_Send(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int PMPI_Recv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Status *status) ; int PMPI_Get_count(const MPI_Status *status, MPI_Datatype datatype, int *count); int PMPI_Bsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int PMPI_Ssend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int PMPI_Rsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm) ; int PMPI_Buffer_attach(void *buffer, int size); int PMPI_Buffer_detach(void *buffer_addr, int *size); int PMPI_Isend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ibsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Issend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Irsend(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Irecv(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Wait(MPI_Request *request, MPI_Status *status); int PMPI_Test(MPI_Request *request, int *flag, MPI_Status *status); int PMPI_Request_free(MPI_Request *request); int PMPI_Waitany(int count, MPI_Request array_of_requests[], int *indx, MPI_Status *status); int PMPI_Testany(int count, MPI_Request array_of_requests[], int *indx, int *flag, MPI_Status *status); int PMPI_Waitall(int count, MPI_Request array_of_requests[], MPI_Status array_of_statuses[]); int PMPI_Testall(int count, MPI_Request array_of_requests[], int *flag, MPI_Status array_of_statuses[]); int PMPI_Waitsome(int incount, MPI_Request array_of_requests[], int *outcount, int array_of_indices[], MPI_Status array_of_statuses[]); int PMPI_Testsome(int incount, MPI_Request array_of_requests[], int *outcount, int array_of_indices[], MPI_Status array_of_statuses[]); int PMPI_Iprobe(int source, int tag, MPI_Comm comm, int *flag, MPI_Status *status); int PMPI_Probe(int source, int tag, MPI_Comm comm, MPI_Status *status); int PMPI_Cancel(MPI_Request *request); int PMPI_Test_cancelled(const MPI_Status *status, int *flag); int PMPI_Send_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Bsend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ssend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Rsend_init(const void *buf, int count, MPI_Datatype datatype, int dest, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Recv_init(void *buf, int count, MPI_Datatype datatype, int source, int tag, MPI_Comm comm, MPI_Request *request) ; int PMPI_Start(MPI_Request *request); int PMPI_Startall(int count, MPI_Request array_of_requests[]); int PMPI_Sendrecv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, int dest, int sendtag, void *recvbuf, int recvcount, MPI_Datatype recvtype, int source, int recvtag, MPI_Comm comm, MPI_Status *status) ; int PMPI_Sendrecv_replace(void *buf, int count, MPI_Datatype datatype, int dest, int sendtag, int source, int recvtag, MPI_Comm comm, MPI_Status *status) ; int PMPI_Type_contiguous(int count, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_vector(int count, int blocklength, int stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_hvector(int count, int blocklength, MPI_Aint stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_indexed(int count, const int *array_of_blocklengths, const int *array_of_displacements, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_hindexed(int count, const int *array_of_blocklengths, const MPI_Aint *array_of_displacements, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_struct(int count, const int *array_of_blocklengths, const MPI_Aint *array_of_displacements, const MPI_Datatype *array_of_types, MPI_Datatype *newtype); int PMPI_Address(const void *location, MPI_Aint *address); int PMPI_Type_extent(MPI_Datatype datatype, MPI_Aint *extent); int PMPI_Type_size(MPI_Datatype datatype, int *size); int PMPI_Type_lb(MPI_Datatype datatype, MPI_Aint *displacement); int PMPI_Type_ub(MPI_Datatype datatype, MPI_Aint *displacement); int PMPI_Type_commit(MPI_Datatype *datatype); int PMPI_Type_free(MPI_Datatype *datatype); int PMPI_Get_elements(const MPI_Status *status, MPI_Datatype datatype, int *count); int PMPI_Pack(const void *inbuf, int incount, MPI_Datatype datatype, void *outbuf, int outsize, int *position, MPI_Comm comm) ; int PMPI_Unpack(const void *inbuf, int insize, int *position, void *outbuf, int outcount, MPI_Datatype datatype, MPI_Comm comm) ; int PMPI_Pack_size(int incount, MPI_Datatype datatype, MPI_Comm comm, int *size); int PMPI_Barrier(MPI_Comm comm); int PMPI_Bcast(void *buffer, int count, MPI_Datatype datatype, int root, MPI_Comm comm) ; int PMPI_Gather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int PMPI_Gatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *displs, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int PMPI_Scatter(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int PMPI_Scatterv(const void *sendbuf, const int *sendcounts, const int *displs, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm) ; int PMPI_Allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *displs, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Alltoallv(const void *sendbuf, const int *sendcounts, const int *sdispls, MPI_Datatype sendtype, void *recvbuf, const int *recvcounts, const int *rdispls, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Alltoallw(const void *sendbuf, const int sendcounts[], const int sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const int rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm); int PMPI_Exscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int PMPI_Reduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, int root, MPI_Comm comm) ; int PMPI_Op_create(MPI_User_function *user_fn, int commute, MPI_Op *op); int PMPI_Op_free(MPI_Op *op); int PMPI_Allreduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int PMPI_Reduce_scatter(const void *sendbuf, void *recvbuf, const int recvcounts[], MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int PMPI_Scan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int PMPI_Group_size(MPI_Group group, int *size); int PMPI_Group_rank(MPI_Group group, int *rank); int PMPI_Group_translate_ranks(MPI_Group group1, int n, const int ranks1[], MPI_Group group2, int ranks2[]); int PMPI_Group_compare(MPI_Group group1, MPI_Group group2, int *result); int PMPI_Comm_group(MPI_Comm comm, MPI_Group *group); int PMPI_Group_union(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int PMPI_Group_intersection(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int PMPI_Group_difference(MPI_Group group1, MPI_Group group2, MPI_Group *newgroup); int PMPI_Group_incl(MPI_Group group, int n, const int ranks[], MPI_Group *newgroup); int PMPI_Group_excl(MPI_Group group, int n, const int ranks[], MPI_Group *newgroup); int PMPI_Group_range_incl(MPI_Group group, int n, int ranges[][3], MPI_Group *newgroup); int PMPI_Group_range_excl(MPI_Group group, int n, int ranges[][3], MPI_Group *newgroup); int PMPI_Group_free(MPI_Group *group); int PMPI_Comm_size(MPI_Comm comm, int *size); int PMPI_Comm_rank(MPI_Comm comm, int *rank); int PMPI_Comm_compare(MPI_Comm comm1, MPI_Comm comm2, int *result); int PMPI_Comm_dup(MPI_Comm comm, MPI_Comm *newcomm); int PMPI_Comm_dup_with_info(MPI_Comm comm, MPI_Info info, MPI_Comm *newcomm); int PMPI_Comm_create(MPI_Comm comm, MPI_Group group, MPI_Comm *newcomm); int PMPI_Comm_split(MPI_Comm comm, int color, int key, MPI_Comm *newcomm); int PMPI_Comm_free(MPI_Comm *comm); int PMPI_Comm_test_inter(MPI_Comm comm, int *flag); int PMPI_Comm_remote_size(MPI_Comm comm, int *size); int PMPI_Comm_remote_group(MPI_Comm comm, MPI_Group *group); int PMPI_Intercomm_create(MPI_Comm local_comm, int local_leader, MPI_Comm peer_comm, int remote_leader, int tag, MPI_Comm *newintercomm); int PMPI_Intercomm_merge(MPI_Comm intercomm, int high, MPI_Comm *newintracomm); int PMPI_Keyval_create(MPI_Copy_function *copy_fn, MPI_Delete_function *delete_fn, int *keyval, void *extra_state); int PMPI_Keyval_free(int *keyval); int PMPI_Attr_put(MPI_Comm comm, int keyval, void *attribute_val); int PMPI_Attr_get(MPI_Comm comm, int keyval, void *attribute_val, int *flag); int PMPI_Attr_delete(MPI_Comm comm, int keyval); int PMPI_Topo_test(MPI_Comm comm, int *status); int PMPI_Cart_create(MPI_Comm comm_old, int ndims, const int dims[], const int periods[], int reorder, MPI_Comm *comm_cart); int PMPI_Dims_create(int nnodes, int ndims, int dims[]); int PMPI_Graph_create(MPI_Comm comm_old, int nnodes, const int indx[], const int edges[], int reorder, MPI_Comm *comm_graph); int PMPI_Graphdims_get(MPI_Comm comm, int *nnodes, int *nedges); int PMPI_Graph_get(MPI_Comm comm, int maxindex, int maxedges, int indx[], int edges[]); int PMPI_Cartdim_get(MPI_Comm comm, int *ndims); int PMPI_Cart_get(MPI_Comm comm, int maxdims, int dims[], int periods[], int coords[]); int PMPI_Cart_rank(MPI_Comm comm, const int coords[], int *rank); int PMPI_Cart_coords(MPI_Comm comm, int rank, int maxdims, int coords[]); int PMPI_Graph_neighbors_count(MPI_Comm comm, int rank, int *nneighbors); int PMPI_Graph_neighbors(MPI_Comm comm, int rank, int maxneighbors, int neighbors[]); int PMPI_Cart_shift(MPI_Comm comm, int direction, int disp, int *rank_source, int *rank_dest); int PMPI_Cart_sub(MPI_Comm comm, const int remain_dims[], MPI_Comm *newcomm); int PMPI_Cart_map(MPI_Comm comm, int ndims, const int dims[], const int periods[], int *newrank); int PMPI_Graph_map(MPI_Comm comm, int nnodes, const int indx[], const int edges[], int *newrank); int PMPI_Get_processor_name(char *name, int *resultlen); int PMPI_Get_version(int *version, int *subversion); int PMPI_Get_library_version(char *version, int *resultlen); int PMPI_Errhandler_create(MPI_Handler_function *function, MPI_Errhandler *errhandler); int PMPI_Errhandler_set(MPI_Comm comm, MPI_Errhandler errhandler); int PMPI_Errhandler_get(MPI_Comm comm, MPI_Errhandler *errhandler); int PMPI_Errhandler_free(MPI_Errhandler *errhandler); int PMPI_Error_string(int errorcode, char *string, int *resultlen); int PMPI_Error_class(int errorcode, int *errorclass); double PMPI_Wtime(void); double PMPI_Wtick(void); int PMPI_Init(int *argc, char ***argv); int PMPI_Finalize(void); int PMPI_Initialized(int *flag); int PMPI_Abort(MPI_Comm comm, int errorcode); int PMPI_Pcontrol(const int level, ...); int PMPI_Close_port(const char *port_name); int PMPI_Comm_accept(const char *port_name, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *newcomm); int PMPI_Comm_connect(const char *port_name, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *newcomm); int PMPI_Comm_disconnect(MPI_Comm *comm); int PMPI_Comm_get_parent(MPI_Comm *parent); int PMPI_Comm_join(int fd, MPI_Comm *intercomm); int PMPI_Comm_spawn(const char *command, char *argv[], int maxprocs, MPI_Info info, int root, MPI_Comm comm, MPI_Comm *intercomm, int array_of_errcodes[]); int PMPI_Comm_spawn_multiple(int count, char *array_of_commands[], char **array_of_argv[], const int array_of_maxprocs[], const MPI_Info array_of_info[], int root, MPI_Comm comm, MPI_Comm *intercomm, int array_of_errcodes[]); int PMPI_Lookup_name(const char *service_name, MPI_Info info, char *port_name); int PMPI_Open_port(MPI_Info info, char *port_name); int PMPI_Publish_name(const char *service_name, MPI_Info info, const char *port_name); int PMPI_Unpublish_name(const char *service_name, MPI_Info info, const char *port_name); int PMPI_Comm_set_info(MPI_Comm comm, MPI_Info info); int PMPI_Comm_get_info(MPI_Comm comm, MPI_Info *info); int PMPI_Accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win) ; int PMPI_Get(void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win) ; int PMPI_Put(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win) ; int PMPI_Win_complete(MPI_Win win); int PMPI_Win_create(void *base, MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, MPI_Win *win); int PMPI_Win_fence(int assert, MPI_Win win); int PMPI_Win_free(MPI_Win *win); int PMPI_Win_get_group(MPI_Win win, MPI_Group *group); int PMPI_Win_lock(int lock_type, int rank, int assert, MPI_Win win); int PMPI_Win_post(MPI_Group group, int assert, MPI_Win win); int PMPI_Win_start(MPI_Group group, int assert, MPI_Win win); int PMPI_Win_test(MPI_Win win, int *flag); int PMPI_Win_unlock(int rank, MPI_Win win); int PMPI_Win_wait(MPI_Win win); int PMPI_Win_allocate(MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, void *baseptr, MPI_Win *win); int PMPI_Win_allocate_shared(MPI_Aint size, int disp_unit, MPI_Info info, MPI_Comm comm, void *baseptr, MPI_Win *win); int PMPI_Win_shared_query(MPI_Win win, int rank, MPI_Aint *size, int *disp_unit, void *baseptr); int PMPI_Win_create_dynamic(MPI_Info info, MPI_Comm comm, MPI_Win *win); int PMPI_Win_attach(MPI_Win win, void *base, MPI_Aint size); int PMPI_Win_detach(MPI_Win win, const void *base); int PMPI_Win_get_info(MPI_Win win, MPI_Info *info_used); int PMPI_Win_set_info(MPI_Win win, MPI_Info info); int PMPI_Get_accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, void *result_addr, int result_count, MPI_Datatype result_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win) ; int PMPI_Fetch_and_op(const void *origin_addr, void *result_addr, MPI_Datatype datatype, int target_rank, MPI_Aint target_disp, MPI_Op op, MPI_Win win) ; int PMPI_Compare_and_swap(const void *origin_addr, const void *compare_addr, void *result_addr, MPI_Datatype datatype, int target_rank, MPI_Aint target_disp, MPI_Win win) ; int PMPI_Rput(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win, MPI_Request *request) ; int PMPI_Rget(void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Win win, MPI_Request *request) ; int PMPI_Raccumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win, MPI_Request *request) ; int PMPI_Rget_accumulate(const void *origin_addr, int origin_count, MPI_Datatype origin_datatype, void *result_addr, int result_count, MPI_Datatype result_datatype, int target_rank, MPI_Aint target_disp, int target_count, MPI_Datatype target_datatype, MPI_Op op, MPI_Win win, MPI_Request *request) ; int PMPI_Win_lock_all(int assert, MPI_Win win); int PMPI_Win_unlock_all(MPI_Win win); int PMPI_Win_flush(int rank, MPI_Win win); int PMPI_Win_flush_all(MPI_Win win); int PMPI_Win_flush_local(int rank, MPI_Win win); int PMPI_Win_flush_local_all(MPI_Win win); int PMPI_Win_sync(MPI_Win win); int PMPI_Add_error_class(int *errorclass); int PMPI_Add_error_code(int errorclass, int *errorcode); int PMPI_Add_error_string(int errorcode, const char *string); int PMPI_Comm_call_errhandler(MPI_Comm comm, int errorcode); int PMPI_Comm_create_keyval(MPI_Comm_copy_attr_function *comm_copy_attr_fn, MPI_Comm_delete_attr_function *comm_delete_attr_fn, int *comm_keyval, void *extra_state); int PMPI_Comm_delete_attr(MPI_Comm comm, int comm_keyval); int PMPI_Comm_free_keyval(int *comm_keyval); int PMPI_Comm_get_attr(MPI_Comm comm, int comm_keyval, void *attribute_val, int *flag); int PMPI_Comm_get_name(MPI_Comm comm, char *comm_name, int *resultlen); int PMPI_Comm_set_attr(MPI_Comm comm, int comm_keyval, void *attribute_val); int PMPI_Comm_set_name(MPI_Comm comm, const char *comm_name); int PMPI_File_call_errhandler(MPI_File fh, int errorcode); int PMPI_Grequest_complete(MPI_Request request); int PMPI_Grequest_start(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, void *extra_state, MPI_Request *request); int PMPI_Init_thread(int *argc, char ***argv, int required, int *provided); int PMPI_Is_thread_main(int *flag); int PMPI_Query_thread(int *provided); int PMPI_Status_set_cancelled(MPI_Status *status, int flag); int PMPI_Status_set_elements(MPI_Status *status, MPI_Datatype datatype, int count); int PMPI_Type_create_keyval(MPI_Type_copy_attr_function *type_copy_attr_fn, MPI_Type_delete_attr_function *type_delete_attr_fn, int *type_keyval, void *extra_state); int PMPI_Type_delete_attr(MPI_Datatype datatype, int type_keyval); int PMPI_Type_dup(MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_free_keyval(int *type_keyval); int PMPI_Type_get_attr(MPI_Datatype datatype, int type_keyval, void *attribute_val, int *flag); int PMPI_Type_get_contents(MPI_Datatype datatype, int max_integers, int max_addresses, int max_datatypes, int array_of_integers[], MPI_Aint array_of_addresses[], MPI_Datatype array_of_datatypes[]); int PMPI_Type_get_envelope(MPI_Datatype datatype, int *num_integers, int *num_addresses, int *num_datatypes, int *combiner); int PMPI_Type_get_name(MPI_Datatype datatype, char *type_name, int *resultlen); int PMPI_Type_set_attr(MPI_Datatype datatype, int type_keyval, void *attribute_val); int PMPI_Type_set_name(MPI_Datatype datatype, const char *type_name); int PMPI_Type_match_size(int typeclass, int size, MPI_Datatype *datatype); int PMPI_Win_call_errhandler(MPI_Win win, int errorcode); int PMPI_Win_create_keyval(MPI_Win_copy_attr_function *win_copy_attr_fn, MPI_Win_delete_attr_function *win_delete_attr_fn, int *win_keyval, void *extra_state); int PMPI_Win_delete_attr(MPI_Win win, int win_keyval); int PMPI_Win_free_keyval(int *win_keyval); int PMPI_Win_get_attr(MPI_Win win, int win_keyval, void *attribute_val, int *flag); int PMPI_Win_get_name(MPI_Win win, char *win_name, int *resultlen); int PMPI_Win_set_attr(MPI_Win win, int win_keyval, void *attribute_val); int PMPI_Win_set_name(MPI_Win win, const char *win_name); int PMPI_Alloc_mem(MPI_Aint size, MPI_Info info, void *baseptr); int PMPI_Comm_create_errhandler(MPI_Comm_errhandler_function *comm_errhandler_fn, MPI_Errhandler *errhandler); int PMPI_Comm_get_errhandler(MPI_Comm comm, MPI_Errhandler *errhandler); int PMPI_Comm_set_errhandler(MPI_Comm comm, MPI_Errhandler errhandler); int PMPI_File_create_errhandler(MPI_File_errhandler_function *file_errhandler_fn, MPI_Errhandler *errhandler); int PMPI_File_get_errhandler(MPI_File file, MPI_Errhandler *errhandler); int PMPI_File_set_errhandler(MPI_File file, MPI_Errhandler errhandler); int PMPI_Finalized(int *flag); int PMPI_Free_mem(void *base); int PMPI_Get_address(const void *location, MPI_Aint *address); int PMPI_Info_create(MPI_Info *info); int PMPI_Info_delete(MPI_Info info, const char *key); int PMPI_Info_dup(MPI_Info info, MPI_Info *newinfo); int PMPI_Info_free(MPI_Info *info); int PMPI_Info_get(MPI_Info info, const char *key, int valuelen, char *value, int *flag); int PMPI_Info_get_nkeys(MPI_Info info, int *nkeys); int PMPI_Info_get_nthkey(MPI_Info info, int n, char *key); int PMPI_Info_get_valuelen(MPI_Info info, const char *key, int *valuelen, int *flag); int PMPI_Info_set(MPI_Info info, const char *key, const char *value); int PMPI_Pack_external(const char datarep[], const void *inbuf, int incount, MPI_Datatype datatype, void *outbuf, MPI_Aint outsize, MPI_Aint *position) ; int PMPI_Pack_external_size(const char datarep[], int incount, MPI_Datatype datatype, MPI_Aint *size); int PMPI_Request_get_status(MPI_Request request, int *flag, MPI_Status *status); int PMPI_Status_c2f(const MPI_Status *c_status, MPI_Fint *f_status); int PMPI_Status_f2c(const MPI_Fint *f_status, MPI_Status *c_status); int PMPI_Type_create_darray(int size, int rank, int ndims, const int array_of_gsizes[], const int array_of_distribs[], const int array_of_dargs[], const int array_of_psizes[], int order, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_create_hindexed(int count, const int array_of_blocklengths[], const MPI_Aint array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_create_hvector(int count, int blocklength, MPI_Aint stride, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_create_indexed_block(int count, int blocklength, const int array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_create_hindexed_block(int count, int blocklength, const MPI_Aint array_of_displacements[], MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_create_resized(MPI_Datatype oldtype, MPI_Aint lb, MPI_Aint extent, MPI_Datatype *newtype); int PMPI_Type_create_struct(int count, const int array_of_blocklengths[], const MPI_Aint array_of_displacements[], const MPI_Datatype array_of_types[], MPI_Datatype *newtype); int PMPI_Type_create_subarray(int ndims, const int array_of_sizes[], const int array_of_subsizes[], const int array_of_starts[], int order, MPI_Datatype oldtype, MPI_Datatype *newtype); int PMPI_Type_get_extent(MPI_Datatype datatype, MPI_Aint *lb, MPI_Aint *extent); int PMPI_Type_get_true_extent(MPI_Datatype datatype, MPI_Aint *true_lb, MPI_Aint *true_extent); int PMPI_Unpack_external(const char datarep[], const void *inbuf, MPI_Aint insize, MPI_Aint *position, void *outbuf, int outcount, MPI_Datatype datatype) ; int PMPI_Win_create_errhandler(MPI_Win_errhandler_function *win_errhandler_fn, MPI_Errhandler *errhandler); int PMPI_Win_get_errhandler(MPI_Win win, MPI_Errhandler *errhandler); int PMPI_Win_set_errhandler(MPI_Win win, MPI_Errhandler errhandler); int PMPI_Type_create_f90_integer(int r, MPI_Datatype *newtype); int PMPI_Type_create_f90_real(int p, int r, MPI_Datatype *newtype); int PMPI_Type_create_f90_complex(int p, int r, MPI_Datatype *newtype); int PMPI_Reduce_local(const void *inbuf, void *inoutbuf, int count, MPI_Datatype datatype, MPI_Op op) ; int PMPI_Op_commutative(MPI_Op op, int *commute); int PMPI_Reduce_scatter_block(const void *sendbuf, void *recvbuf, int recvcount, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm) ; int PMPI_Dist_graph_create_adjacent(MPI_Comm comm_old, int indegree, const int sources[], const int sourceweights[], int outdegree, const int destinations[], const int destweights[], MPI_Info info, int reorder, MPI_Comm *comm_dist_graph); int PMPI_Dist_graph_create(MPI_Comm comm_old, int n, const int sources[], const int degrees[], const int destinations[], const int weights[], MPI_Info info, int reorder, MPI_Comm *comm_dist_graph); int PMPI_Dist_graph_neighbors_count(MPI_Comm comm, int *indegree, int *outdegree, int *weighted); int PMPI_Dist_graph_neighbors(MPI_Comm comm, int maxindegree, int sources[], int sourceweights[], int maxoutdegree, int destinations[], int destweights[]); int PMPI_Improbe(int source, int tag, MPI_Comm comm, int *flag, MPI_Message *message, MPI_Status *status); int PMPI_Imrecv(void *buf, int count, MPI_Datatype datatype, MPI_Message *message, MPI_Request *request) ; int PMPI_Mprobe(int source, int tag, MPI_Comm comm, MPI_Message *message, MPI_Status *status); int PMPI_Mrecv(void *buf, int count, MPI_Datatype datatype, MPI_Message *message, MPI_Status *status) ; int PMPI_Comm_idup(MPI_Comm comm, MPI_Comm *newcomm, MPI_Request *request); int PMPI_Ibarrier(MPI_Comm comm, MPI_Request *request); int PMPI_Ibcast(void *buffer, int count, MPI_Datatype datatype, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Igather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Igatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iscatter(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iscatterv(const void *sendbuf, const int sendcounts[], const int displs[], MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iallgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iallgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ialltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ialltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ialltoallw(const void *sendbuf, const int sendcounts[], const int sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const int rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm, MPI_Request *request); int PMPI_Ireduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, int root, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iallreduce(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ireduce_scatter(const void *sendbuf, void *recvbuf, const int recvcounts[], MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ireduce_scatter_block(const void *sendbuf, void *recvbuf, int recvcount, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int PMPI_Iexscan(const void *sendbuf, void *recvbuf, int count, MPI_Datatype datatype, MPI_Op op, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ineighbor_allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ineighbor_allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ineighbor_alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ineighbor_alltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm, MPI_Request *request) ; int PMPI_Ineighbor_alltoallw(const void *sendbuf, const int sendcounts[], const MPI_Aint sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const MPI_Aint rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm, MPI_Request *request); int PMPI_Neighbor_allgather(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Neighbor_allgatherv(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int displs[], MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Neighbor_alltoall(const void *sendbuf, int sendcount, MPI_Datatype sendtype, void *recvbuf, int recvcount, MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Neighbor_alltoallv(const void *sendbuf, const int sendcounts[], const int sdispls[], MPI_Datatype sendtype, void *recvbuf, const int recvcounts[], const int rdispls[], MPI_Datatype recvtype, MPI_Comm comm) ; int PMPI_Neighbor_alltoallw(const void *sendbuf, const int sendcounts[], const MPI_Aint sdispls[], const MPI_Datatype sendtypes[], void *recvbuf, const int recvcounts[], const MPI_Aint rdispls[], const MPI_Datatype recvtypes[], MPI_Comm comm); int PMPI_Comm_split_type(MPI_Comm comm, int split_type, int key, MPI_Info info, MPI_Comm *newcomm); int PMPI_Comm_create_group(MPI_Comm comm, MPI_Group group, int tag, MPI_Comm *newcomm); int PMPI_Get_elements_x(const MPI_Status *status, MPI_Datatype datatype, MPI_Count *count); int PMPI_Status_set_elements_x(MPI_Status *status, MPI_Datatype datatype, MPI_Count count); int PMPI_Type_get_extent_x(MPI_Datatype datatype, MPI_Count *lb, MPI_Count *extent); int PMPI_Type_get_true_extent_x(MPI_Datatype datatype, MPI_Count *lb, MPI_Count *extent); int PMPI_Type_size_x(MPI_Datatype datatype, MPI_Count *size); MPI_Aint PMPI_Aint_add(MPI_Aint base, MPI_Aint disp); MPI_Aint PMPI_Aint_diff(MPI_Aint addr1, MPI_Aint addr2); int PMPI_T_init_thread(int required, int *provided); int PMPI_T_finalize(void); int PMPI_T_enum_get_info(MPI_T_enum enumtype, int *num, char *name, int *name_len); int PMPI_T_enum_get_item(MPI_T_enum enumtype, int indx, int *value, char *name, int *name_len); int PMPI_T_cvar_get_num(int *num_cvar); int PMPI_T_cvar_get_info(int cvar_index, char *name, int *name_len, int *verbosity, MPI_Datatype *datatype, MPI_T_enum *enumtype, char *desc, int *desc_len, int *binding, int *scope); int PMPI_T_cvar_handle_alloc(int cvar_index, void *obj_handle, MPI_T_cvar_handle *handle, int *count); int PMPI_T_cvar_handle_free(MPI_T_cvar_handle *handle); int PMPI_T_cvar_read(MPI_T_cvar_handle handle, void *buf); int PMPI_T_cvar_write(MPI_T_cvar_handle handle, const void *buf); int PMPI_T_pvar_get_num(int *num_pvar); int PMPI_T_pvar_get_info(int pvar_index, char *name, int *name_len, int *verbosity, int *var_class, MPI_Datatype *datatype, MPI_T_enum *enumtype, char *desc, int *desc_len, int *binding, int *readonly, int *continuous, int *atomic); int PMPI_T_pvar_session_create(MPI_T_pvar_session *session); int PMPI_T_pvar_session_free(MPI_T_pvar_session *session); int PMPI_T_pvar_handle_alloc(MPI_T_pvar_session session, int pvar_index, void *obj_handle, MPI_T_pvar_handle *handle, int *count); int PMPI_T_pvar_handle_free(MPI_T_pvar_session session, MPI_T_pvar_handle *handle); int PMPI_T_pvar_start(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int PMPI_T_pvar_stop(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int PMPI_T_pvar_read(MPI_T_pvar_session session, MPI_T_pvar_handle handle, void *buf); int PMPI_T_pvar_write(MPI_T_pvar_session session, MPI_T_pvar_handle handle, const void *buf); int PMPI_T_pvar_reset(MPI_T_pvar_session session, MPI_T_pvar_handle handle); int PMPI_T_pvar_readreset(MPI_T_pvar_session session, MPI_T_pvar_handle handle, void *buf); int PMPI_T_category_get_num(int *num_cat); int PMPI_T_category_get_info(int cat_index, char *name, int *name_len, char *desc, int *desc_len, int *num_cvars, int *num_pvars, int *num_categories); int PMPI_T_category_get_cvars(int cat_index, int len, int indices[]); int PMPI_T_category_get_pvars(int cat_index, int len, int indices[]); int PMPI_T_category_get_categories(int cat_index, int len, int indices[]); int PMPI_T_category_changed(int *stamp); int PMPI_T_cvar_get_index(const char *name, int *cvar_index); int PMPI_T_pvar_get_index(const char *name, int var_class, int *pvar_index); int PMPI_T_category_get_index(const char *name, int *cat_index); int PMPIX_Comm_failure_ack(MPI_Comm comm); int PMPIX_Comm_failure_get_acked(MPI_Comm comm, MPI_Group *failedgrp); int PMPIX_Comm_revoke(MPI_Comm comm); int PMPIX_Comm_shrink(MPI_Comm comm, MPI_Comm *newcomm); int PMPIX_Comm_agree(MPI_Comm comm, int *flag); #line 2340 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 1 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 1 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 80 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 99 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 106 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 123 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 140 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 150 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 160 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 182 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" int MPI_File_open(MPI_Comm comm, const char *filename, int amode, MPI_Info info, MPI_File *fh); int MPI_File_close(MPI_File *fh); int MPI_File_delete(const char *filename, MPI_Info info); int MPI_File_set_size(MPI_File fh, MPI_Offset size); int MPI_File_preallocate(MPI_File fh, MPI_Offset size); int MPI_File_get_size(MPI_File fh, MPI_Offset *size); int MPI_File_get_group(MPI_File fh, MPI_Group *group); int MPI_File_get_amode(MPI_File fh, int *amode); int MPI_File_set_info(MPI_File fh, MPI_Info info); int MPI_File_get_info(MPI_File fh, MPI_Info *info_used); int MPI_File_set_view(MPI_File fh, MPI_Offset disp, MPI_Datatype etype, MPI_Datatype filetype, const char *datarep, MPI_Info info); int MPI_File_get_view(MPI_File fh, MPI_Offset *disp, MPI_Datatype *etype, MPI_Datatype *filetype, char *datarep); int MPI_File_read_at(MPI_File fh, MPI_Offset offset, void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_read_at_all(MPI_File fh, MPI_Offset offset, void * buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write_at(MPI_File fh, MPI_Offset offset, const void * buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write_at_all(MPI_File fh, MPI_Offset offset, const void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_iread_at(MPI_File fh, MPI_Offset offset, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iwrite_at(MPI_File fh, MPI_Offset offset, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_read(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_read_all(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write_all(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_iread(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iwrite(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_seek(MPI_File fh, MPI_Offset offset, int whence); int MPI_File_get_position(MPI_File fh, MPI_Offset *offset); int MPI_File_get_byte_offset(MPI_File fh, MPI_Offset offset, MPI_Offset *disp); int MPI_File_read_shared(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write_shared(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_iread_shared(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iwrite_shared(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_read_ordered(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_write_ordered(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Status *status) ; int MPI_File_seek_shared(MPI_File fh, MPI_Offset offset, int whence); int MPI_File_get_position_shared(MPI_File fh, MPI_Offset *offset); int MPI_File_read_at_all_begin(MPI_File fh, MPI_Offset offset, void *buf, int count, MPI_Datatype datatype) ; int MPI_File_read_at_all_end(MPI_File fh, void *buf, MPI_Status *status); int MPI_File_write_at_all_begin(MPI_File fh, MPI_Offset offset, const void *buf, int count, MPI_Datatype datatype) ; int MPI_File_write_at_all_end(MPI_File fh, const void *buf, MPI_Status *status); int MPI_File_read_all_begin(MPI_File fh, void *buf, int count, MPI_Datatype datatype) ; int MPI_File_read_all_end(MPI_File fh, void *buf, MPI_Status *status); int MPI_File_write_all_begin(MPI_File fh, const void *buf, int count, MPI_Datatype datatype) ; int MPI_File_write_all_end(MPI_File fh, const void *buf, MPI_Status *status); int MPI_File_read_ordered_begin(MPI_File fh, void *buf, int count, MPI_Datatype datatype) ; int MPI_File_read_ordered_end(MPI_File fh, void *buf, MPI_Status *status); int MPI_File_write_ordered_begin(MPI_File fh, const void *buf, int count, MPI_Datatype datatype) ; int MPI_File_write_ordered_end(MPI_File fh, const void *buf, MPI_Status *status); int MPI_File_get_type_extent(MPI_File fh, MPI_Datatype datatype, MPI_Aint *extent); int MPI_Register_datarep(const char *datarep, MPI_Datarep_conversion_function *read_conversion_fn, MPI_Datarep_conversion_function *write_conversion_fn, MPI_Datarep_extent_function *dtype_file_extent_fn, void *extra_state); int MPI_File_set_atomicity(MPI_File fh, int flag); int MPI_File_get_atomicity(MPI_File fh, int *flag); int MPI_File_sync(MPI_File fh); int MPI_File_iread_at_all(MPI_File fh, MPI_Offset offset, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iwrite_at_all(MPI_File fh, MPI_Offset offset, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iread_all(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int MPI_File_iwrite_all(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; #line 338 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 351 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" MPI_File MPI_File_f2c(MPI_Fint file); MPI_Fint MPI_File_c2f(MPI_File file); #line 376 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 405 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" int PMPI_File_open(MPI_Comm, const char *, int, MPI_Info, MPI_File *); int PMPI_File_close(MPI_File *); int PMPI_File_delete(const char *, MPI_Info); int PMPI_File_set_size(MPI_File, MPI_Offset); int PMPI_File_preallocate(MPI_File, MPI_Offset); int PMPI_File_get_size(MPI_File, MPI_Offset *); int PMPI_File_get_group(MPI_File, MPI_Group *); int PMPI_File_get_amode(MPI_File, int *); int PMPI_File_set_info(MPI_File, MPI_Info); int PMPI_File_get_info(MPI_File, MPI_Info *); int PMPI_File_set_view(MPI_File, MPI_Offset, MPI_Datatype, MPI_Datatype, const char *, MPI_Info); int PMPI_File_get_view(MPI_File, MPI_Offset *, MPI_Datatype *, MPI_Datatype *, char *); int PMPI_File_read_at(MPI_File, MPI_Offset, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_read_at_all(MPI_File, MPI_Offset, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write_at(MPI_File, MPI_Offset, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write_at_all(MPI_File, MPI_Offset, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_iread_at(MPI_File, MPI_Offset, void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_iwrite_at(MPI_File, MPI_Offset, const void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_read(MPI_File, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_read_all(MPI_File, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write(MPI_File, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write_all(MPI_File, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_iread(MPI_File, void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_iwrite(MPI_File, const void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_seek(MPI_File, MPI_Offset, int); int PMPI_File_get_position(MPI_File, MPI_Offset *); int PMPI_File_get_byte_offset(MPI_File, MPI_Offset, MPI_Offset *); int PMPI_File_read_shared(MPI_File, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write_shared(MPI_File, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_iread_shared(MPI_File, void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_iwrite_shared(MPI_File, const void *, int, MPI_Datatype, MPI_Request *) ; int PMPI_File_read_ordered(MPI_File, void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_write_ordered(MPI_File, const void *, int, MPI_Datatype, MPI_Status *) ; int PMPI_File_seek_shared(MPI_File, MPI_Offset, int); int PMPI_File_get_position_shared(MPI_File, MPI_Offset *); int PMPI_File_read_at_all_begin(MPI_File, MPI_Offset, void *, int, MPI_Datatype) ; int PMPI_File_read_at_all_end(MPI_File, void *, MPI_Status *); int PMPI_File_write_at_all_begin(MPI_File, MPI_Offset, const void *, int, MPI_Datatype) ; int PMPI_File_write_at_all_end(MPI_File, const void *, MPI_Status *); int PMPI_File_read_all_begin(MPI_File, void *, int, MPI_Datatype) ; int PMPI_File_read_all_end(MPI_File, void *, MPI_Status *); int PMPI_File_write_all_begin(MPI_File, const void *, int, MPI_Datatype) ; int PMPI_File_write_all_end(MPI_File, const void *, MPI_Status *); int PMPI_File_read_ordered_begin(MPI_File, void *, int, MPI_Datatype) ; int PMPI_File_read_ordered_end(MPI_File, void *, MPI_Status *); int PMPI_File_write_ordered_begin(MPI_File, const void *, int, MPI_Datatype) ; int PMPI_File_write_ordered_end(MPI_File, const void *, MPI_Status *); int PMPI_File_get_type_extent(MPI_File, MPI_Datatype, MPI_Aint *); int PMPI_Register_datarep(const char *, MPI_Datarep_conversion_function *, MPI_Datarep_conversion_function *, MPI_Datarep_extent_function *, void *); int PMPI_File_set_atomicity(MPI_File, int); int PMPI_File_get_atomicity(MPI_File, int *); int PMPI_File_sync(MPI_File); int PMPI_File_iread_at_all(MPI_File fh, MPI_Offset offset, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int PMPI_File_iwrite_at_all(MPI_File fh, MPI_Offset offset, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int PMPI_File_iread_all(MPI_File fh, void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; int PMPI_File_iwrite_all(MPI_File fh, const void *buf, int count, MPI_Datatype datatype, MPI_Request *request) ; #line 563 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" MPI_File PMPI_File_f2c(MPI_Fint); MPI_Fint PMPI_File_c2f(MPI_File); #line 583 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 600 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpio.h" #line 2342 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" #line 2360 "E:\\PROGRA~4\\INTELS~1\\COMPIL~2\\windows\\mpi\\intel64\\include\\mpi.h" typedef int MPIX_Grequest_class; int MPIX_Grequest_class_create(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, MPIX_Grequest_poll_function *poll_fn, MPIX_Grequest_wait_function *wait_fn, MPIX_Grequest_class *greq_class); int MPIX_Grequest_class_allocate(MPIX_Grequest_class greq_class, void *extra_state, MPI_Request *request); int MPIX_Grequest_start(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, MPIX_Grequest_poll_function *poll_fn, MPIX_Grequest_wait_function *wait_fn, void *extra_state, MPI_Request *request); struct mpixi_mutex_s; typedef struct mpixi_mutex_s * MPIX_Mutex; int MPIX_Mutex_create(int count, MPI_Comm comm, MPIX_Mutex *hdl); int MPIX_Mutex_free(MPIX_Mutex *hdl); int MPIX_Mutex_lock(MPIX_Mutex hdl, int mutex, int proc); int MPIX_Mutex_unlock(MPIX_Mutex hdl, int mutex, int proc); int PMPIX_Grequest_class_create(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, MPIX_Grequest_poll_function *poll_fn, MPIX_Grequest_wait_function *wait_fn, MPIX_Grequest_class *greq_class); int PMPIX_Grequest_class_allocate(MPIX_Grequest_class greq_class, void *extra_state, MPI_Request *request); int PMPIX_Grequest_start(MPI_Grequest_query_function *query_fn, MPI_Grequest_free_function *free_fn, MPI_Grequest_cancel_function *cancel_fn, MPIX_Grequest_poll_function *poll_fn, MPIX_Grequest_wait_function *wait_fn, void *extra_state, MPI_Request *request); int PMPIX_Mutex_create(int count, MPI_Comm comm, MPIX_Mutex *hdl); int PMPIX_Mutex_free(MPIX_Mutex *hdl); int PMPIX_Mutex_lock(MPIX_Mutex hdl, int mutex, int proc); int PMPIX_Mutex_unlock(MPIX_Mutex hdl, int mutex, int proc); #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.MPI\\conftest.c" int mpich_ver = 0; Defined "HAVE_I_MPI_NUMVERSION" to "0" ================================================================================ TEST configureMPI2 from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:183) TESTING: configureMPI2 from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:183) Check for functions added to the interface in MPI-2 Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int flag;if (MPI_Finalized(&flag)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPI_FINALIZED" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { if (MPI_Allreduce(MPI_IN_PLACE,0, 1, MPI_INT, MPI_SUM, MPI_COMM_SELF)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPI_IN_PLACE" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int count=2; int blocklens[2]={0,1}; MPI_Aint indices[2]={0,1}; MPI_Datatype old_types[2]={0,1}; MPI_Datatype *newtype = 0; if (MPI_Type_create_struct(count, blocklens, indices, old_types, newtype)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { MPI_Comm_errhandler_fn * p_err_fun = 0; MPI_Errhandler * p_errhandler = 0; if (MPI_Comm_create_errhandler(p_err_fun,p_errhandler)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { if (MPI_Comm_set_errhandler(MPI_COMM_WORLD,MPI_ERRORS_RETURN)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { if (MPI_Reduce_local(0, 0, 0, MPI_INT, MPI_SUM));; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPI_REDUCE_LOCAL" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { char version[MPI_MAX_LIBRARY_VERSION_STRING];int verlen;if (MPI_Get_library_version(version,&verlen)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPI_GET_LIBRARY_VERSION" to "1" ================================================================================ TEST configureMPI3 from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:222) TESTING: configureMPI3 from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:222) Check for functions added to the interface in MPI-3 Checking for functions [MPI_Win_create] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char MPI_Win_create(); static void _check_MPI_Win_create() { MPI_Win_create(); } int main() { _check_MPI_Win_create();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_LIBIMPI" to "1" Popping language C Defined "HAVE_MPI_WIN_CREATE" to "1" Defined "HAVE_MPI_REPLACE" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { MPI_Comm scomm; if (MPI_Comm_split_type(MPI_COMM_WORLD, MPI_COMM_TYPE_SHARED, 0, MPI_INFO_NULL, &scomm)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPI_SHARED_COMM" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { MPI_Win win; if (MPI_Win_allocate_shared(100,10,MPI_INFO_NULL,MPI_COMM_WORLD, 0, &win)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPI_WIN_ALLOCATE_SHARED" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { if (MPI_Win_shared_query(MPI_WIN_NULL,0,0,0,0)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPI_WIN_SHARED_QUERY" to "1" Defined "HAVE_MPI_WIN_CREATE_FEATURE" to "1" ================================================================================ TEST configureTypes from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:268) TESTING: configureTypes from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:268) Checking for MPI types Checking for size of type: MPI_Comm Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif #define MPICH_IGNORE_CXX_SEEK #define MPICH_SKIP_MPICXX 1 #define OMPI_SKIP_MPICXX 1 #include int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(MPI_Comm)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Ws2_32.lib Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_MPI_COMM" to "4" Checking for size of type: MPI_Fint Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif #define MPICH_IGNORE_CXX_SEEK #define MPICH_SKIP_MPICXX 1 #define OMPI_SKIP_MPICXX 1 #include int main() { FILE *f = fopen("conftestval", "w"); if (!f) exit(1); fprintf(f, "%lu\n", (unsigned long)sizeof(MPI_Fint)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.o Ws2_32.lib Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types/conftest.exe Popping language C Defined "SIZEOF_MPI_FINT" to "4" ================================================================================ TEST configureMPITypes from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:280) TESTING: configureMPITypes from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:280) Checking for MPI Datatype handles Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #ifdef PETSC_HAVE_STDLIB_H #include #endif #include int main() { MPI_Aint size; int ierr; MPI_Init(0,0); ierr = MPI_Type_extent(MPI_LONG_DOUBLE, &size); if(ierr || (size == 0)) exit(1); MPI_Finalize(); ; return 0; } Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #ifdef PETSC_HAVE_STDLIB_H #include #endif #include int main() { MPI_Aint size; int ierr; MPI_Init(0,0); ierr = MPI_Type_extent(MPI_LONG_DOUBLE, &size); if(ierr || (size == 0)) exit(1); MPI_Finalize(); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe Defined "HAVE_MPI_LONG_DOUBLE" to "1" Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #ifdef PETSC_HAVE_STDLIB_H #include #endif #include int main() { MPI_Aint size; int ierr; MPI_Init(0,0); ierr = MPI_Type_extent(MPI_INT64_T, &size); if(ierr || (size == 0)) exit(1); MPI_Finalize(); ; return 0; } Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #ifdef PETSC_HAVE_STDLIB_H #include #endif #include int main() { MPI_Aint size; int ierr; MPI_Init(0,0); ierr = MPI_Type_extent(MPI_INT64_T, &size); if(ierr || (size == 0)) exit(1); MPI_Finalize(); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe Defined "HAVE_MPI_INT64_T" to "1" Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #ifdef PETSC_HAVE_STDLIB_H #include #endif #include int main() { MPI_Aint size; int ierr; MPI_Init(0,0); ierr = MPI_Type_extent(MPI_C_DOUBLE_COMPLEX, &size); if(ierr || (size == 0)) exit(1); MPI_Finalize(); ; return 0; } Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #ifdef PETSC_HAVE_STDLIB_H #include #endif #include int main() { MPI_Aint size; int ierr; MPI_Init(0,0); ierr = MPI_Type_extent(MPI_C_DOUBLE_COMPLEX, &size); if(ierr || (size == 0)) exit(1); MPI_Finalize(); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe Defined "HAVE_MPI_C_DOUBLE_COMPLEX" to "1" Popping language C ================================================================================ TEST configureMissingPrototypes from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:353) TESTING: configureMissingPrototypes from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:353) Checks for missing prototypes, which it adds to petscfix.h ================================================================================ TEST SGIMPICheck from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:372) TESTING: SGIMPICheck from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:372) Returns true if SGI MPI is used Checking for functions [MPI_SGI_barrier] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char MPI_SGI_barrier(); static void _check_MPI_SGI_barrier() { MPI_SGI_barrier(); } int main() { _check_MPI_SGI_barrier();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib stdout: conftest.obj : error LNK2019: unresolved external symbol MPI_SGI_barrier referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol MPI_SGI_barrier referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C SGI MPI test failure ================================================================================ TEST CxxMPICheck from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:382) TESTING: CxxMPICheck from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:382) Make sure C++ can compile and link Pushing language Cxx Checking for header mpi.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { ; return 0; } Checking for C++ MPI_Finalize() Checking for functions [MPI_Finalize] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language Cxx Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp -TP -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.cc stdout: conftest.cc Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ #include static void _check_MPI_Finalize() { int ierr; ierr = MPI_Finalize();; } int main() { _check_MPI_Finalize();; return 0; } Pushing language CXX Popping language CXX Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_LIBIMPI" to "1" Popping language Cxx Popping language Cxx ================================================================================ TEST FortranMPICheck from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:400) TESTING: FortranMPICheck from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:400) Make sure fortran include [mpif.h] and library symbols are found Pushing language FC Checking for header mpif.h Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.F90 Successful compile: Source: program main #include "mpif.h" end Checking for fortran mpi_init() Checking for functions [] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.F90 Successful compile: Source: program main #include "mpif.h" integer ierr call mpi_init(ierr) end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_LIBIMPI" to "1" Popping language FC Checking for mpi.mod Checking for functions [] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.F90 Successful compile: Source: program main use mpi integer ierr,rank call mpi_init(ierr) call mpi_comm_rank(MPI_COMM_WORLD,rank,ierr) end Pushing language FC Popping language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -MT -O2 -Qopenmp -fpp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_LIBIMPI" to "1" Popping language FC Defined "HAVE_MPI_F90MODULE" to "1" Popping language FC ================================================================================ TEST configureIO from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:425) TESTING: configureIO from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:425) Check for the functions in MPI/IO - Define HAVE_MPIIO if they are present - Some older MPI 1 implementations are missing these Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { MPI_Aint lb, extent; if (MPI_Type_get_extent(MPI_INT, &lb, &extent)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.MPI\conftest.c(9): warning #592: variable "fh" is used before its value is set if (MPI_File_write_all(fh, buf, 1, MPI_INT, &status)); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.MPI\conftest.c(9): warning #592: variable "buf" is used before its value is set if (MPI_File_write_all(fh, buf, 1, MPI_INT, &status)); ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { MPI_File fh; void *buf; MPI_Status status; if (MPI_File_write_all(fh, buf, 1, MPI_INT, &status)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.MPI\conftest.c(9): warning #592: variable "fh" is used before its value is set if (MPI_File_read_all(fh, buf, 1, MPI_INT, &status)); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.MPI\conftest.c(9): warning #592: variable "buf" is used before its value is set if (MPI_File_read_all(fh, buf, 1, MPI_INT, &status)); ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { MPI_File fh; void *buf; MPI_Status status; if (MPI_File_read_all(fh, buf, 1, MPI_INT, &status)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.MPI\conftest.c(9): warning #592: variable "fh" is used before its value is set if (MPI_File_set_view(fh, disp, MPI_INT, MPI_INT, "", info)); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.MPI\conftest.c(9): warning #592: variable "disp" is used before its value is set if (MPI_File_set_view(fh, disp, MPI_INT, MPI_INT, "", info)); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.MPI\conftest.c(9): warning #592: variable "info" is used before its value is set if (MPI_File_set_view(fh, disp, MPI_INT, MPI_INT, "", info)); ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { MPI_File fh; MPI_Offset disp; MPI_Info info; if (MPI_File_set_view(fh, disp, MPI_INT, MPI_INT, "", info)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.MPI\conftest.c(8): warning #592: variable "info" is used before its value is set if (MPI_File_open(MPI_COMM_SELF, "", 0, info, &fh)); ^ Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { MPI_File fh; MPI_Info info; if (MPI_File_open(MPI_COMM_SELF, "", 0, info, &fh)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { MPI_File fh; MPI_Info info; if (MPI_File_close(&fh)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_MPIIO" to "1" ================================================================================ TEST findMPIInc from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:499) TESTING: findMPIInc from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:499) Find MPI include paths from "mpicc -show" and use with CUDAC_FLAGS Checking for functions [MPI_Alltoallw] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char MPI_Alltoallw(); static void _check_MPI_Alltoallw() { MPI_Alltoallw(); } int main() { _check_MPI_Alltoallw();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_LIBIMPI" to "1" Popping language C Checking for functions [MPI_Type_create_indexed_block] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char MPI_Type_create_indexed_block(); static void _check_MPI_Type_create_indexed_block() { MPI_Type_create_indexed_block(); } int main() { _check_MPI_Type_create_indexed_block();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_LIBIMPI" to "1" Popping language C Defined "HAVE_MPI_ALLTOALLW" to "1" Checking for functions [MPI_Comm_spawn MPI_Type_get_envelope MPI_Type_get_extent MPI_Type_dup MPI_Init_thread MPI_Iallreduce MPI_Ibarrier MPI_Finalized MPI_Exscan MPI_Reduce_scatter MPI_Reduce_scatter_block] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char MPI_Comm_spawn(); static void _check_MPI_Comm_spawn() { MPI_Comm_spawn(); } char MPI_Type_get_envelope(); static void _check_MPI_Type_get_envelope() { MPI_Type_get_envelope(); } char MPI_Type_get_extent(); static void _check_MPI_Type_get_extent() { MPI_Type_get_extent(); } char MPI_Type_dup(); static void _check_MPI_Type_dup() { MPI_Type_dup(); } char MPI_Init_thread(); static void _check_MPI_Init_thread() { MPI_Init_thread(); } char MPI_Iallreduce(); static void _check_MPI_Iallreduce() { MPI_Iallreduce(); } char MPI_Ibarrier(); static void _check_MPI_Ibarrier() { MPI_Ibarrier(); } char MPI_Finalized(); static void _check_MPI_Finalized() { MPI_Finalized(); } char MPI_Exscan(); static void _check_MPI_Exscan() { MPI_Exscan(); } char MPI_Reduce_scatter(); static void _check_MPI_Reduce_scatter() { MPI_Reduce_scatter(); } char MPI_Reduce_scatter_block(); static void _check_MPI_Reduce_scatter_block() { MPI_Reduce_scatter_block(); } int main() { _check_MPI_Comm_spawn(); _check_MPI_Type_get_envelope(); _check_MPI_Type_get_extent(); _check_MPI_Type_dup(); _check_MPI_Init_thread(); _check_MPI_Iallreduce(); _check_MPI_Ibarrier(); _check_MPI_Finalized(); _check_MPI_Exscan(); _check_MPI_Reduce_scatter(); _check_MPI_Reduce_scatter_block();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Defined "HAVE_LIBIMPI" to "1" Popping language C Defined "HAVE_MPI_COMM_SPAWN" to "1" Defined "HAVE_MPI_TYPE_GET_ENVELOPE" to "1" Defined "HAVE_MPI_TYPE_GET_EXTENT" to "1" Defined "HAVE_MPI_TYPE_DUP" to "1" Defined "HAVE_MPI_INIT_THREAD" to "1" Defined "HAVE_MPI_IALLREDUCE" to "1" Defined "HAVE_MPI_IBARRIER" to "1" Defined "HAVE_MPI_FINALIZED" to "1" Defined "HAVE_MPI_EXSCAN" to "1" Defined "HAVE_MPI_REDUCE_SCATTER" to "1" Defined "HAVE_MPI_REDUCE_SCATTER_BLOCK" to "1" Checking for functions [MPIX_Iallreduce] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char MPIX_Iallreduce(); static void _check_MPIX_Iallreduce() { MPIX_Iallreduce(); } int main() { _check_MPIX_Iallreduce();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib stdout: conftest.obj : error LNK2019: unresolved external symbol MPIX_Iallreduce referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol MPIX_Iallreduce referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C Checking for functions [MPIX_Ibarrier] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char MPIX_Ibarrier(); static void _check_MPIX_Ibarrier() { MPIX_Ibarrier(); } int main() { _check_MPIX_Ibarrier();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib stdout: conftest.obj : error LNK2019: unresolved external symbol MPIX_Ibarrier referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol MPIX_Ibarrier referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int combiner = MPI_COMBINER_DUP;; return 0; } Defined "HAVE_MPI_COMBINER_DUP" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int combiner = MPI_COMBINER_CONTIGUOUS;; return 0; } Defined "HAVE_MPI_COMBINER_CONTIGUOUS" to "1" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include int main() { int combiner = MPI_COMBINER_NAMED;; return 0; } Defined "HAVE_MPI_COMBINER_NAMED" to "1" Checking for functions [MPIDI_CH3I_sock_set] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char MPIDI_CH3I_sock_set(); static void _check_MPIDI_CH3I_sock_set() { MPIDI_CH3I_sock_set(); } int main() { _check_MPIDI_CH3I_sock_set();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib stdout: conftest.obj : error LNK2019: unresolved external symbol MPIDI_CH3I_sock_set referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol MPIDI_CH3I_sock_set referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C Checking for functions [MPIDI_CH3I_sock_fixed_nbc_progress] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char MPIDI_CH3I_sock_fixed_nbc_progress(); static void _check_MPIDI_CH3I_sock_fixed_nbc_progress() { MPIDI_CH3I_sock_fixed_nbc_progress(); } int main() { _check_MPIDI_CH3I_sock_fixed_nbc_progress();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib stdout: conftest.obj : error LNK2019: unresolved external symbol MPIDI_CH3I_sock_fixed_nbc_progress referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol MPIDI_CH3I_sock_fixed_nbc_progress referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C ================================================================================ TEST checkSharedLibrary from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:131) TESTING: checkSharedLibrary from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:131) Sets flag indicating if MPI libraries are shared or not and determines if MPI libraries CANNOT be used by shared libraries ================================================================================ TEST configureMPIEXEC from config.packages.MPI(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/MPI.py:144) TESTING: configureMPIEXEC from config.packages.MPI(config/BuildSystem/config/packages/MPI.py:144) Checking for mpiexec Pushing language C Popping language C Checking for program /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec...found Defined make macro "MPIEXEC" to "/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec" Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #ifdef __cplusplus extern "C" #endif int init(int argc, char *argv[]) { int isInitialized; MPI_Init(&argc, &argv); MPI_Initialized(&isInitialized); return (int) isInitialized; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/libconftest.dll -LD -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #ifdef __cplusplus extern "C" #endif int checkInit(void) { int isInitialized; MPI_Initialized(&isInitialized); if (isInitialized) MPI_Finalize(); return (int) isInitialized; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/libconftest.dll -LD -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Ws2_32.lib Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c(19): error: identifier "RTLD_LAZY" is undefined lib = dlopen("/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/lib1.dll", RTLD_LAZY); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c(19): warning #556: a value of type "int" cannot be assigned to an entity of type "void *" lib = dlopen("/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/lib1.dll", RTLD_LAZY); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c(33): warning #556: a value of type "int" cannot be assigned to an entity of type "void *" lib = dlopen("/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/lib2.dll", RTLD_LAZY); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c (code 2) Possible ERROR while running compiler: exit code 512 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c(19): error: identifier "RTLD_LAZY" is undefined lib = dlopen("/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/lib1.dll", RTLD_LAZY); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c(19): warning #556: a value of type "int" cannot be assigned to an entity of type "void *" lib = dlopen("/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/lib1.dll", RTLD_LAZY); ^ C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c(33): warning #556: a value of type "int" cannot be assigned to an entity of type "void *" lib = dlopen("/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/lib2.dll", RTLD_LAZY); ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.c (code 2)Source: #include "confdefs.h" #include "conffix.h" #include #include #ifdef PETSC_HAVE_DLFCN_H #include #endif int main() { int argc = 1; char *argv[2] = {(char *) "conftest", NULL}; void *lib; int (*init)(int, char **); int (*checkInit)(void); lib = dlopen("/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/lib1.dll", RTLD_LAZY); if (!lib) { fprintf(stderr, "Could not open lib1.so: %s\n", dlerror()); exit(1); } init = (int (*)(int, char **)) dlsym(lib, "init"); if (!init) { fprintf(stderr, "Could not find initialization function\n"); exit(1); } if (!(*init)(argc, argv)) { fprintf(stderr, "Could not initialize library\n"); exit(1); } lib = dlopen("/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/lib2.dll", RTLD_LAZY); if (!lib) { fprintf(stderr, "Could not open lib2.so: %s\n", dlerror()); exit(1); } checkInit = (int (*)(void)) dlsym(lib, "checkInit"); if (!checkInit) { fprintf(stderr, "Could not find initialization check function\n"); exit(1); } if (!(*checkInit)()) { fprintf(stderr, "Did not link with shared library\n"); exit(2); } ; return 0; } Compile failed inside link Library was not shared Popping language C ================================================================================ TEST alternateConfigureLibrary from config.packages.yaml(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.yaml(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default Pushing language C ================================================================================ TEST configureLibrary from config.packages.valgrind(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:746) TESTING: configureLibrary from config.packages.valgrind(config/BuildSystem/config/package.py:746) Find an installation and check if it can work with PETSc ================================================================================== Checking for a functional valgrind Not checking for library in Compiler specific search VALGRIND: [] because no functions given to check for ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names No functions to check for in library [] [] Checking for headers Compiler specific search VALGRIND: [] Pushing language C ================================================================================ TEST checkInclude from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:86) TESTING: checkInclude from config.headers(config/BuildSystem/config/headers.py:86) Checks if a particular include file can be found along particular include paths Checking for header files ['valgrind/valgrind.h'] in [] Checking include with compiler flags var CPPFLAGS [] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "valgrind/valgrind.h" #include ^ #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "valgrind/valgrind.h" #include ^ #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: Popping language C Not checking for library in Package specific search directory VALGRIND: [] because no functions given to check for ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names No functions to check for in library [] [] Checking for headers Package specific search directory VALGRIND: ['/usr/local/include'] Pushing language C ================================================================================ TEST checkInclude from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:86) TESTING: checkInclude from config.headers(config/BuildSystem/config/headers.py:86) Checks if a particular include file can be found along particular include paths Checking for header files ['valgrind/valgrind.h'] in ['/usr/local/include'] Checking include with compiler flags var CPPFLAGS ['/usr/local/include'] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/usr/local/include /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "valgrind/valgrind.h" #include ^ #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.headers\conftest.c(3): error #2379: cannot open source file "valgrind/valgrind.h" #include ^ #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: Popping language C VALGRIND: DirPath not found.. skipping: /usr/local/lib64 VALGRIND: SearchDir DirPath not found.. skipping: /opt/local Executing: uname -s stdout: CYGWIN_NT-6.1 Popping language C ================================================================================ TEST alternateConfigureLibrary from config.packages.ssl(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.ssl(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.sprng(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.sprng(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default Not a clone of PETSc or no Fortran compiler or fortran-bindings disabled, don't need Sowing ================================================================================ TEST alternateConfigureLibrary from config.packages.slepc(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/slepc.py:81) TESTING: alternateConfigureLibrary from config.packages.slepc(config/BuildSystem/config/packages/slepc.py:81) Defined make rule "slepc-build" with dependencies "" and code [] Defined make rule "slepc-install" with dependencies "" and code [] ================================================================================ TEST alternateConfigureLibrary from config.packages.revolve(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.revolve(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.radau5(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.radau5(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default Pushing language C ================================================================================ TEST checkDependencies from config.packages.pthread(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:721) TESTING: checkDependencies from config.packages.pthread(config/BuildSystem/config/package.py:721) ================================================================================ TEST configureLibrary from config.packages.pthread(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/pthread.py:19) TESTING: configureLibrary from config.packages.pthread(config/BuildSystem/config/packages/pthread.py:19) Checks for pthread_barrier_t, cpu_set_t, and sys/sysctl.h ================================================================================== Checking for a functional pthread Checking for library in Compiler specific search PTHREAD: [] ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [pthread_create] in library [] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char pthread_create(); static void _check_pthread_create() { pthread_create(); } int main() { _check_pthread_create();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o Ws2_32.lib stdout: conftest.obj : error LNK2019: unresolved external symbol pthread_create referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol pthread_create referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C Checking for library in Compiler specific search PTHREAD: ['libpthread.a'] ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [pthread_create] in library ['libpthread.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char pthread_create(); static void _check_pthread_create() { pthread_create(); } int main() { _check_pthread_create();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libpthread.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libpthread.lib' Popping language C All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.pthread\conftest.c(3): catastrophic error: cannot open source file "pthread.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.pthread\conftest.c (code 4) Possible ERROR while running compiler: exit code 1024 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.pthread\conftest.c(3): catastrophic error: cannot open source file "pthread.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.pthread\conftest.c (code 4)Source: #include "confdefs.h" #include "conffix.h" #include int main() { pthread_barrier_t *a; ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread/conftest.c stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.pthread\conftest.c(3): catastrophic error: cannot open source file "sched.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.pthread\conftest.c (code 4) Possible ERROR while running compiler: exit code 1024 stdout: conftest.c C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.pthread\conftest.c(3): catastrophic error: cannot open source file "sched.h" #include ^ compilation aborted for C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.pthread\conftest.c (code 4)Source: #include "confdefs.h" #include "conffix.h" #include int main() { cpu_set_t *a; ; return 0; } Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.pthread\conftest.c(3): error #2379: cannot open source file "sys/sysctl.h" #include ^ #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\conftest.c" Possible ERROR while running preprocessor: exit code 512 stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.packages.pthread\conftest.c(3): error #2379: cannot open source file "sys/sysctl.h" #include ^ #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.packages.pthread\\conftest.c"Source: #include "confdefs.h" #include "conffix.h" #include Preprocess stderr before filtering:: Preprocess stderr after filtering:: ================================================================================ TEST checkSharedLibrary from config.packages.pthread(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:799) TESTING: checkSharedLibrary from config.packages.pthread(config/BuildSystem/config/package.py:799) By default we don't care about checking if the library is shared Popping language C ================================================================================ TEST alternateConfigureLibrary from config.packages.pami(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.pami(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.opengles(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.opengles(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.opencl(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.opencl(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.mpe(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.mpe(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.memkind(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.memkind(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.libmesh(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/libmesh.py:76) TESTING: alternateConfigureLibrary from config.packages.libmesh(config/BuildSystem/config/packages/libmesh.py:76) Defined make rule "libmesh-build" with dependencies "" and code [] Defined make rule "libmesh-install" with dependencies "" and code [] ================================================================================ TEST alternateConfigureLibrary from config.packages.moose(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.moose(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.libjpeg(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.libjpeg(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default Not a clone of PETSc, don't need Lgrind ================================================================================ TEST alternateConfigureLibrary from config.packages.gmp(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.gmp(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.mpfr(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.mpfr(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.opengl(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.opengl(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.glut(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.glut(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.giflib(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.giflib(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.cuda(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.cuda(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.cusp(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.cusp(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.ctetgen(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.ctetgen(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.concurrencykit(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.concurrencykit(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST locateC2html from config.packages.c2html(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/c2html.py:32) TESTING: locateC2html from config.packages.c2html(config/BuildSystem/config/packages/c2html.py:32) Looking for default C2html executable Checking for program /usr/bin/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/bin/intel64/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/compiler/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.15.26726/bin/HostX64/x64/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/VC/VCPackages/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/TypeScript/3.0/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TestWindow/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/TeamFoundation/Team Explorer/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/Roslyn/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/x64/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Team Tools/Performance Tools/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/x64/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/Shared/Common/VSPerfCollectionTools/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft SDKs/Windows/v10.0A/bin/NETFX 4.6.1 Tools/x64/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/HTML Help Workshop/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/10.0.17134.0/x64/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Windows Kits/10/bin/x64/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/MSBuild/15.0/bin/c2html...not found Checking for program /cygdrive/c/Windows/Microsoft.NET/Framework64/v4.0.30319/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/Tools/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/gdb/intel64/bin/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/debugger_2018/libipt/intel64/lib/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/ipp/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/mkl/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/compiler/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64/tbb/vc_mt/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/daal/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries/windows/redist/intel64_win/tbb/vc_mt/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Oracle/Java/javapath/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/compilers_and_libraries_2018.3.210/windows/mpi/intel64/bin/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/mpirt/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/mpirt/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64_win/compiler/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32_win/compiler/c2html...not found Checking for program /cygdrive/e/Python37/Scripts/c2html...not found Checking for program /cygdrive/e/Python37/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IntelSWTools/mpi/2018.1.156/intel64/bin/c2html...not found Checking for program /cygdrive/c/Program Files/Microsoft MPI/Bin/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI-RT/4.1.3.045/em64t/bin/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/CMG/CMGJobService/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.3.050/intel64/bin/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/mpirt/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/mpirt/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/intel64/compiler/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Common Files/Intel/Shared Libraries/redist/ia32/compiler/c2html...not found Checking for program /cygdrive/c/ProgramData/Oracle/Java/javapath/c2html...not found Checking for program /cygdrive/c/Python27/c2html...not found Checking for program /cygdrive/c/Python27/Scripts/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/bin/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/MPI/5.0.2.044/intel64/bin/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Composer XE 2015/bin/ia32/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86_64/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/AMD APP SDK/2.9/bin/x86/c2html...not found Checking for program /cygdrive/c/Progra/c2html...not found Checking for program /cygdrive/c/Windows/System32/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Microsoft Visual Studio 14.0/Common7/IDE/c2html...not found Checking for program /cygdrive/e/Program Files/PuTTY/c2html...not found Checking for program /cygdrive/c/ecl/HOME/c2html...not found Checking for program /cygdrive/c/ecl/MACROS/c2html...not found Checking for program /cygdrive/e/Program Files/CMake/bin/c2html...not found Checking for program /cygdrive/e/ecl/HOME/c2html...not found Checking for program /cygdrive/e/ecl/MACROS/c2html...not found Checking for program /cygdrive/c/Program Files/dotnet/c2html...not found Checking for program /cygdrive/c/Program Files/Microsoft SQL Server/130/Tools/Binn/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/VC/Tools/MSVC/14.14.26428/bin/Hostx64/x64/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/IncrediBuild/c2html...not found Checking for program /cygdrive/e/Python36/Scripts/c2html...not found Checking for program /cygdrive/e/Python36/c2html...not found Checking for program /cygdrive/c/Users/AliReza/.dnx/bin/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/Intel/Trace Analyzer and Collector/9.0.2.045/dll/c2html...not found Checking for program /cygdrive/c/Program Files (x86)/SSH Communications Security/SSH Secure Shell/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/CMake/bin/c2html...not found Checking for program /cygdrive/e/Program Files (x86)/Microsoft Visual Studio/2017/Enterprise/Common7/IDE/CommonExtensions/Microsoft/CMake/Ninja/c2html...not found Checking for program /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/c2html...not found ================================================================================ TEST alternateConfigureLibrary from config.packages.boost(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.boost(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.openmp(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.openmp(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.viennacl(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.viennacl(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.hwloc(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.hwloc(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default Pushing language C ================================================================================ TEST checkDependencies from config.packages.X(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:721) TESTING: checkDependencies from config.packages.X(config/BuildSystem/config/package.py:721) ================================================================================ TEST configureLibrary from config.packages.X(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:746) TESTING: configureLibrary from config.packages.X(config/BuildSystem/config/package.py:746) Find an installation and check if it can work with PETSc ================================================================================== Checking for a functional X Checking for library in Compiler specific search X: [] ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [XSetWMName] in library [] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char XSetWMName(); static void _check_XSetWMName() { XSetWMName(); } int main() { _check_XSetWMName();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o Ws2_32.lib stdout: conftest.obj : error LNK2019: unresolved external symbol XSetWMName referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol XSetWMName referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C Checking for library in Compiler specific search X: ['libX11.a'] ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [XSetWMName] in library ['libX11.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char XSetWMName(); static void _check_XSetWMName() { XSetWMName(); } int main() { _check_XSetWMName();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -lX11 Ws2_32.lib stdout: ipo: error #11018: Cannot open libX11.lib LINK : fatal error LNK1181: cannot open input file 'libX11.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libX11.lib LINK : fatal error LNK1181: cannot open input file 'libX11.lib' Popping language C X: SearchDir DirPath not found.. skipping: /opt/X11 X: SearchDir DirPath not found.. skipping: /Developer/SDKs/MacOSX10.5.sdk/usr/X11 X: SearchDir DirPath not found.. skipping: /Developer/SDKs/MacOSX10.4u.sdk/usr/X11R6 X: SearchDir DirPath not found.. skipping: /usr/X11 X: SearchDir DirPath not found.. skipping: /usr/X11R6 X: SearchDir DirPath not found.. skipping: /usr/X11R5 X: SearchDir DirPath not found.. skipping: /usr/X11R4 X: SearchDir DirPath not found.. skipping: /usr/local/X11 X: SearchDir DirPath not found.. skipping: /usr/local/X11R6 X: SearchDir DirPath not found.. skipping: /usr/local/X11R5 X: SearchDir DirPath not found.. skipping: /usr/local/X11R4 X: SearchDir DirPath not found.. skipping: /usr/X386 X: SearchDir DirPath not found.. skipping: /usr/x386 X: SearchDir DirPath not found.. skipping: /usr/XFree86/X11 Checking for library in Package specific search directory X: ['/usr/local/lib/libX11.a'] Contents: ['bin', 'etc', 'include', 'lib', 'TrilinosRepoVersion.txt'] ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [XSetWMName] in library ['/usr/local/lib/libX11.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char XSetWMName(); static void _check_XSetWMName() { XSetWMName(); } int main() { _check_XSetWMName();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/usr/local/lib -L/usr/local/lib -lX11 Ws2_32.lib stdout: ipo: error #11018: Cannot open libX11.lib LINK : fatal error LNK1181: cannot open input file 'libX11.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libX11.lib LINK : fatal error LNK1181: cannot open input file 'libX11.lib' Popping language C X: DirPath not found.. skipping: /usr/local/lib64 X: SearchDir DirPath not found.. skipping: /usr/local/x11r5 X: SearchDir DirPath not found.. skipping: /usr/lpp/Xamples X: SearchDir DirPath not found.. skipping: /usr/openwin X: SearchDir DirPath not found.. skipping: /usr/openwin/share ================================================================================ TEST checkSharedLibrary from config.packages.X(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:799) TESTING: checkSharedLibrary from config.packages.X(config/BuildSystem/config/package.py:799) By default we don't care about checking if the library is shared Popping language C ================================================================================ TEST alternateConfigureLibrary from config.packages.Random123(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.Random123(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.PARTY(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.PARTY(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.Numpy(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.Numpy(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.petsc4py(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/petsc4py.py:123) TESTING: alternateConfigureLibrary from config.packages.petsc4py(config/BuildSystem/config/packages/petsc4py.py:123) Defined make rule "petsc4py-build" with dependencies "" and code [] Defined make rule "petsc4py-install" with dependencies "" and code [] ================================================================================ TEST alternateConfigureLibrary from config.packages.mpi4py(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/mpi4py.py:71) TESTING: alternateConfigureLibrary from config.packages.mpi4py(config/BuildSystem/config/packages/mpi4py.py:71) Defined make rule "mpi4py-build" with dependencies "" and code [] Defined make rule "mpi4py-install" with dependencies "" and code [] ================================================================================ TEST alternateConfigureLibrary from config.packages.Matlab(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.Matlab(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.MatlabEngine(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.MatlabEngine(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.Mathematica(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.Mathematica(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.szlib(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.szlib(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.zlib(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.zlib(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST locateCMake from config.packages.cmake(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/cmake.py:34) TESTING: locateCMake from config.packages.cmake(config/BuildSystem/config/packages/cmake.py:34) Looking for default CMake executable Checking for program /usr/bin/cmake...found Defined make macro "CMAKE" to "/usr/bin/cmake" Looking for default CTest executable Checking for program /usr/bin/ctest...found Defined make macro "CTEST" to "/usr/bin/ctest" ================================================================================ TEST alternateConfigureLibrary from config.packages.googletest(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.googletest(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.unittestcpp(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.unittestcpp(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.eigen(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.eigen(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.tetgen(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.tetgen(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.tchem(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.tchem(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.saws(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.saws(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.libpng(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.libpng(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.Triangle(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.Triangle(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.PTScotch(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.PTScotch(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.metis(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.metis(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.pragmatic(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.pragmatic(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.parmetis(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.parmetis(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.Zoltan(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.Zoltan(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.hdf5(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.hdf5(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.med(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.med(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.cgns(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.cgns(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.ascem-io(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.ascem-io(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.pflotran(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.pflotran(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.alquimia(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.alquimia(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.Chaco(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.Chaco(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.pnetcdf(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.pnetcdf(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.netcdf(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.netcdf(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.exodusii(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.exodusii(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.openblas(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.openblas(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.fblaslapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.fblaslapack(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.f2cblaslapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.f2cblaslapack(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default Pushing language C ================================================================================ TEST checkDependencies from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:721) TESTING: checkDependencies from config.packages.BlasLapack(config/BuildSystem/config/package.py:721) ================================================================================ TEST configureLibrary from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:351) TESTING: configureLibrary from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:351) Looking for BLAS/LAPACK in user specified directory: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win Files and directories in that directory: ['mkl_blacs_ilp64_dll.lib', 'mkl_blacs_intelmpi_ilp64.lib', 'mkl_blacs_intelmpi_lp64.lib', 'mkl_blacs_lp64_dll.lib', 'mkl_blacs_mpich2_ilp64.lib', 'mkl_blacs_mpich2_lp64.lib', 'mkl_blacs_msmpi_ilp64.lib', 'mkl_blacs_msmpi_lp64.lib', 'mkl_blas95_ilp64.lib', 'mkl_blas95_lp64.lib', 'mkl_cdft_core.lib', 'mkl_cdft_core_dll.lib', 'mkl_core.lib', 'mkl_core_dll.lib', 'mkl_intel_ilp64.lib', 'mkl_intel_ilp64_dll.lib', 'mkl_intel_lp64.lib', 'mkl_intel_lp64_dll.lib', 'mkl_intel_thread.lib', 'mkl_intel_thread_dll.lib', 'mkl_lapack95_ilp64.lib', 'mkl_lapack95_lp64.lib', 'mkl_rt.lib', 'mkl_scalapack_ilp64.lib', 'mkl_scalapack_ilp64_dll.lib', 'mkl_scalapack_lp64.lib', 'mkl_scalapack_lp64_dll.lib', 'mkl_sequential.lib', 'mkl_sequential_dll.lib', 'mkl_tbb_thread.lib', 'mkl_tbb_thread_dll.lib'] ================================================================================ Checking for a functional BLAS and LAPACK in User specified installation root (HPUX) ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libveclib.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lveclib Ws2_32.lib stdout: ipo: error #11018: Cannot open libveclib.lib LINK : fatal error LNK1181: cannot open input file 'libveclib.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libveclib.lib LINK : fatal error LNK1181: cannot open input file 'libveclib.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libveclib.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lveclib Ws2_32.lib stdout: ipo: error #11018: Cannot open libveclib.lib LINK : fatal error LNK1181: cannot open input file 'libveclib.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libveclib.lib LINK : fatal error LNK1181: cannot open input file 'libveclib.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libveclib.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lveclib Ws2_32.lib stdout: ipo: error #11018: Cannot open libveclib.lib LINK : fatal error LNK1181: cannot open input file 'libveclib.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libveclib.lib LINK : fatal error LNK1181: cannot open input file 'libveclib.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified installation root (F2CBLASLAPACK) ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libf2cblas.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lf2cblas Ws2_32.lib stdout: ipo: error #11018: Cannot open libf2cblas.lib LINK : fatal error LNK1181: cannot open input file 'libf2cblas.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libf2cblas.lib LINK : fatal error LNK1181: cannot open input file 'libf2cblas.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libf2cblas.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lf2cblas Ws2_32.lib stdout: ipo: error #11018: Cannot open libf2cblas.lib LINK : fatal error LNK1181: cannot open input file 'libf2cblas.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libf2cblas.lib LINK : fatal error LNK1181: cannot open input file 'libf2cblas.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libf2cblas.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lf2cblas Ws2_32.lib stdout: ipo: error #11018: Cannot open libf2cblas.lib LINK : fatal error LNK1181: cannot open input file 'libf2cblas.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libf2cblas.lib LINK : fatal error LNK1181: cannot open input file 'libf2cblas.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified installation root(FBLASLAPACK) ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libfblas.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lfblas Ws2_32.lib stdout: ipo: error #11018: Cannot open libfblas.lib LINK : fatal error LNK1181: cannot open input file 'libfblas.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libfblas.lib LINK : fatal error LNK1181: cannot open input file 'libfblas.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libfblas.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lfblas Ws2_32.lib stdout: ipo: error #11018: Cannot open libfblas.lib LINK : fatal error LNK1181: cannot open input file 'libfblas.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libfblas.lib LINK : fatal error LNK1181: cannot open input file 'libfblas.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libfblas.a'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lfblas Ws2_32.lib stdout: ipo: error #11018: Cannot open libfblas.lib LINK : fatal error LNK1181: cannot open input file 'libfblas.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libfblas.lib LINK : fatal error LNK1181: cannot open input file 'libfblas.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MATLAB [ILP64] MKL Linux lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so', '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64/libiomp5.so', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 -liomp5 -lpthread Ws2_32.lib stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so', '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64/libiomp5.so', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 -liomp5 -lpthread Ws2_32.lib stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so', '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64/libiomp5.so', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 -liomp5 -lpthread Ws2_32.lib stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/glnxa64 icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/glnxa64/mkl.so' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MATLAB [ILP64] MKL MacOS lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib', '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64/libiomp5.dylib', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -Wl,-rpath,/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 -liomp5 -lpthread Ws2_32.lib stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 icl: command line warning #10157: ignoring option '/W'; argument is of wrong type icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 icl: command line warning #10157: ignoring option '/W'; argument is of wrong type icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib', '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64/libiomp5.dylib', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -Wl,-rpath,/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 -liomp5 -lpthread Ws2_32.lib stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 icl: command line warning #10157: ignoring option '/W'; argument is of wrong type icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 icl: command line warning #10157: ignoring option '/W'; argument is of wrong type icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib', '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64/libiomp5.dylib', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -Wl,-rpath,/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64 -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 -liomp5 -lpthread Ws2_32.lib stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 icl: command line warning #10157: ignoring option '/W'; argument is of wrong type icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: File Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/sys/os/maci64 icl: command line warning #10157: ignoring option '/W'; argument is of wrong type icl: command line warning #10006: ignoring unknown option '/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/bin/maci64/mkl.dylib' ipo: error #11018: Cannot open libiomp5.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libiomp5.lib' Popping language C Unknown name mangling in BLAS/LAPACK MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/ia32 MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/32 MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/ia32 ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL11/12 Linux32 ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_intel.a', 'mkl_sequential', 'mkl_core', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_intel -lmkl_sequential -lmkl_core -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_intel.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_intel.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_intel.a', 'mkl_sequential', 'mkl_core', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_intel -lmkl_sequential -lmkl_core -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_intel.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_intel.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_intel.a', 'mkl_sequential', 'mkl_core', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_intel -lmkl_sequential -lmkl_core -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_intel.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_intel.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel.lib' Popping language C Unknown name mangling in BLAS/LAPACK MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/ia64 MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/intel64 MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/64 MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/ia64 MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/em64t MKL Path not found.. skipping: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/intel64 ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL11/12 Linux64 ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_intel_lp64.a', 'mkl_sequential', 'mkl_core', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_intel_lp64 -lmkl_sequential -lmkl_core -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel_lp64.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel_lp64.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_intel_lp64.a', 'mkl_sequential', 'mkl_core', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_intel_lp64 -lmkl_sequential -lmkl_core -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel_lp64.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel_lp64.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_intel_lp64.a', 'mkl_sequential', 'mkl_core', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_intel_lp64 -lmkl_sequential -lmkl_core -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel_lp64.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libmkl_sequential.lib ipo: error #11018: Cannot open libmkl_core.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_intel_lp64.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t/libmkl_lapack.a', 'mkl', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -lmkl_lapack -lmkl -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux-x86 lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_def -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_def -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_def -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux-x86 lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'vml', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_def -lguide -lvml -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'vml', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_def -lguide -lvml -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'vml', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_def -lguide -lvml -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux-ia64 lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_ipf.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_ipf -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_ipf.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_ipf -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_ipf.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_ipf -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux-em64t lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_em64t.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_em64t -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_em64t.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_em64t -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_em64t.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_em64t -lguide -lpthread Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux-x86 installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_def -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_def -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_def -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux-x86 installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'vml', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_def -lguide -lvml -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'vml', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_def -lguide -lvml -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_def.a', 'guide', 'vml', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_def -lguide -lvml -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_def.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libvml.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux-ia64 installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64/libmkl_lapack.a', 'libmkl_ipf.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -lmkl_lapack -lmkl_ipf -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64/libmkl_lapack.a', 'libmkl_ipf.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -lmkl_lapack -lmkl_ipf -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64/libmkl_lapack.a', 'libmkl_ipf.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 -lmkl_lapack -lmkl_ipf -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/64 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ipf.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Linux-em64t installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t/libmkl_lapack.a', 'libmkl_em64t.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -lmkl_lapack -lmkl_em64t -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t/libmkl_lapack.a', 'libmkl_em64t.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -lmkl_lapack -lmkl_em64t -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t/libmkl_lapack.a', 'libmkl_em64t.a', 'guide', 'pthread'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t -lmkl_lapack -lmkl_em64t -lguide -lpthread Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/em64t ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_em64t.lib ipo: error #11018: Cannot open libguide.lib ipo: error #11018: Cannot open libpthread.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Mac-x86 lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_ia32.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_ia32 -lguide Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_ia32.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_ia32 -lguide Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_ia32.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_ia32 -lguide Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Max-x86 installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32/libmkl_lapack.a', 'libmkl_ia32.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -lmkl_lapack -lmkl_ia32 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32/libmkl_lapack.a', 'libmkl_ia32.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -lmkl_lapack -lmkl_ia32 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32/libmkl_lapack.a', 'libmkl_ia32.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -lmkl_lapack -lmkl_ia32 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Max-x86 installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_ia32.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_ia32 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_ia32.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_ia32 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_ia32.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_ia32 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_ia32.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Mac-em64t lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_intel_lp64.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_intel_lp64 -lguide Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_intel_lp64.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_intel_lp64 -lguide Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/libmkl_lapack.a', 'libmkl_intel_lp64.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win -lmkl_lapack -lmkl_intel_lp64 -lguide Ws2_32.lib stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Max-em64t installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32/libmkl_lapack.a', 'libmkl_intel_lp64.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -lmkl_lapack -lmkl_intel_lp64 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32/libmkl_lapack.a', 'libmkl_intel_lp64.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -lmkl_lapack -lmkl_intel_lp64 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32/libmkl_lapack.a', 'libmkl_intel_lp64.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 -lmkl_lapack -lmkl_intel_lp64 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/Libraries/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Max-em64t installation root ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_intel_lp64.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_intel_lp64 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_intel_lp64.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_intel_lp64 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32/libmkl_lapack.a', 'libmkl_intel_lp64.a', 'guide'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -L/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 -lmkl_lapack -lmkl_intel_lp64 -lguide Ws2_32.lib stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Possible ERROR while running linker: exit code 40192 stdout: Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 Warning: win32fe: Library Path Not Found: /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/lib/32 ipo: error #11018: Cannot open libmkl_lapack.lib ipo: error #11018: Cannot open libmkl_intel_lp64.lib ipo: error #11018: Cannot open libguide.lib LINK : fatal error LNK1181: cannot open input file 'libmkl_lapack.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL Windows lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_c_dll.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_c_dll.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_c_dll.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_c_dll.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_c_dll.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_c_dll.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_c_dll.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified stdcall MKL Windows lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_s_dll.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_s_dll.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_s_dll.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_s_dll.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_s_dll.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_s_dll.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_s_dll.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified ia64/em64t MKL Windows lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_dll.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_dll.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_dll.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_dll.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_dll.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_dll.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_dll.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL10-32 Windows lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_c_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_c_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_c_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_c_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_c_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_c_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_c_dll.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL10-32 Windows stdcall lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_s_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_s_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib' Popping language C Checking for no name mangling on BLAS/LAPACK Checking for functions [Ddot] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_s_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot(); static void _check_Ddot() { Ddot(); } int main() { _check_Ddot();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_s_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib' Popping language C Checking for underscore name mangling on BLAS/LAPACK Checking for functions [Ddot_] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_s_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char Ddot_(); static void _check_Ddot_() { Ddot_(); } int main() { _check_Ddot_();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_s_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib' Possible ERROR while running linker: exit code 40192 stdout: ipo: error #11018: Cannot open E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib LINK : fatal error LNK1181: cannot open input file 'E:\PROGRA~4\INTELS~1\COMPIL~2\windows\mkl\lib\INTEL6~1\mkl_intel_s_dll.lib' Popping language C Unknown name mangling in BLAS/LAPACK ================================================================================ Checking for a functional BLAS and LAPACK in User specified MKL10-64 Windows lib dir ================================================================================ TEST checkLib from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:114) TESTING: checkLib from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:114) Checking for BLAS and LAPACK symbols Checking for functions [DDOT] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DDOT(); static void _check_DDOT() { DDOT(); } int main() { _check_DDOT();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Defined "HAVE_LIBMKL_INTEL_LP64_DLL" to "1" Defined "HAVE_LIBMKL_INTEL_THREAD_DLL" to "1" Defined "HAVE_LIBMKL_CORE_DLL" to "1" Defined "HAVE_LIBIOMP5MD" to "1" Popping language C Checking for functions [DGETRS] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DGETRS(); static void _check_DGETRS() { DGETRS(); } int main() { _check_DGETRS();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Defined "HAVE_LIBMKL_INTEL_LP64_DLL" to "1" Defined "HAVE_LIBMKL_INTEL_THREAD_DLL" to "1" Defined "HAVE_LIBMKL_CORE_DLL" to "1" Defined "HAVE_LIBIOMP5MD" to "1" Popping language C Checking for functions [DGEEV] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DGEEV(); static void _check_DGEEV() { DGEEV(); } int main() { _check_DGEEV();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Defined "HAVE_LIBMKL_INTEL_LP64_DLL" to "1" Defined "HAVE_LIBMKL_INTEL_THREAD_DLL" to "1" Defined "HAVE_LIBMKL_CORE_DLL" to "1" Defined "HAVE_LIBIOMP5MD" to "1" Popping language C Found Fortran mangling on BLAS/LAPACK which is caps Defined "BLASLAPACK_CAPS" to "1" ================================================================================ TEST checkESSL from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:431) TESTING: checkESSL from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:431) Check for the IBM ESSL library Checking for functions [iessl] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char iessl(); static void _check_iessl() { iessl(); } int main() { _check_iessl();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib stdout: conftest.obj : error LNK2019: unresolved external symbol iessl referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol iessl referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C ================================================================================ TEST checkPESSL from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:471) TESTING: checkPESSL from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:471) Check for the IBM PESSL library - and error out - if used instead of ESSL Checking for functions [ipessl] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char ipessl(); static void _check_ipessl() { ipessl(); } int main() { _check_ipessl();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib stdout: conftest.obj : error LNK2019: unresolved external symbol ipessl referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Possible ERROR while running linker: exit code 24576 stdout: conftest.obj : error LNK2019: unresolved external symbol ipessl referenced in function main C:\Users\AliReza\AppData\Local\Temp\petsc-fh63UE\config.libraries\conftest.exe : fatal error LNK1120: 1 unresolved externals Popping language C ================================================================================ TEST checkMKL from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:439) TESTING: checkMKL from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:439) Check for Intel MKL library Defined "HAVE_MKL" to "1" All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include "mkl_spblas.h" int main() { ; return 0; } Checking for functions [mkl_set_num_threads] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char mkl_set_num_threads(); static void _check_mkl_set_num_threads() { mkl_set_num_threads(); } int main() { _check_mkl_set_num_threads();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Defined "HAVE_LIBMKL_INTEL_LP64_DLL" to "1" Defined "HAVE_LIBMKL_INTEL_THREAD_DLL" to "1" Defined "HAVE_LIBMKL_CORE_DLL" to "1" Defined "HAVE_LIBIOMP5MD" to "1" Popping language C ================================================================================ TEST checkMissing from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:496) TESTING: checkMissing from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:496) Check for missing LAPACK routines Checking for functions [DGEEV DGELS DGELSS DGEQRF DGERFS DGESV DGESVD DGETRF DGETRI DGETRS DGGES DHGEQZ DHSEQR DORMQR DPOTRF DPOTRI DPOTRS DPTTRF DPTTRS DSTEBZ DSTEIN DSTEQR DSYEV DSYEVX DSYGVX DSYTRF DSYTRI DSYTRS DTGSEN DTRSEN DTRTRS DORGQR] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DGEEV(); static void _check_DGEEV() { DGEEV(); } char DGELS(); static void _check_DGELS() { DGELS(); } char DGELSS(); static void _check_DGELSS() { DGELSS(); } char DGEQRF(); static void _check_DGEQRF() { DGEQRF(); } char DGERFS(); static void _check_DGERFS() { DGERFS(); } char DGESV(); static void _check_DGESV() { DGESV(); } char DGESVD(); static void _check_DGESVD() { DGESVD(); } char DGETRF(); static void _check_DGETRF() { DGETRF(); } char DGETRI(); static void _check_DGETRI() { DGETRI(); } char DGETRS(); static void _check_DGETRS() { DGETRS(); } char DGGES(); static void _check_DGGES() { DGGES(); } char DHGEQZ(); static void _check_DHGEQZ() { DHGEQZ(); } char DHSEQR(); static void _check_DHSEQR() { DHSEQR(); } char DORMQR(); static void _check_DORMQR() { DORMQR(); } char DPOTRF(); static void _check_DPOTRF() { DPOTRF(); } char DPOTRI(); static void _check_DPOTRI() { DPOTRI(); } char DPOTRS(); static void _check_DPOTRS() { DPOTRS(); } char DPTTRF(); static void _check_DPTTRF() { DPTTRF(); } char DPTTRS(); static void _check_DPTTRS() { DPTTRS(); } char DSTEBZ(); static void _check_DSTEBZ() { DSTEBZ(); } char DSTEIN(); static void _check_DSTEIN() { DSTEIN(); } char DSTEQR(); static void _check_DSTEQR() { DSTEQR(); } char DSYEV(); static void _check_DSYEV() { DSYEV(); } char DSYEVX(); static void _check_DSYEVX() { DSYEVX(); } char DSYGVX(); static void _check_DSYGVX() { DSYGVX(); } char DSYTRF(); static void _check_DSYTRF() { DSYTRF(); } char DSYTRI(); static void _check_DSYTRI() { DSYTRI(); } char DSYTRS(); static void _check_DSYTRS() { DSYTRS(); } char DTGSEN(); static void _check_DTGSEN() { DTGSEN(); } char DTRSEN(); static void _check_DTRSEN() { DTRSEN(); } char DTRTRS(); static void _check_DTRTRS() { DTRTRS(); } char DORGQR(); static void _check_DORGQR() { DORGQR(); } int main() { _check_DGEEV(); _check_DGELS(); _check_DGELSS(); _check_DGEQRF(); _check_DGERFS(); _check_DGESV(); _check_DGESVD(); _check_DGETRF(); _check_DGETRI(); _check_DGETRS(); _check_DGGES(); _check_DHGEQZ(); _check_DHSEQR(); _check_DORMQR(); _check_DPOTRF(); _check_DPOTRI(); _check_DPOTRS(); _check_DPTTRF(); _check_DPTTRS(); _check_DSTEBZ(); _check_DSTEIN(); _check_DSTEQR(); _check_DSYEV(); _check_DSYEVX(); _check_DSYGVX(); _check_DSYTRF(); _check_DSYTRI(); _check_DSYTRS(); _check_DTGSEN(); _check_DTRSEN(); _check_DTRTRS(); _check_DORGQR();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Defined "HAVE_LIBMKL_INTEL_LP64_DLL" to "1" Defined "HAVE_LIBMKL_INTEL_THREAD_DLL" to "1" Defined "HAVE_LIBMKL_CORE_DLL" to "1" Defined "HAVE_LIBIOMP5MD" to "1" Popping language C ================================================================================ TEST checklsame from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:514) TESTING: checklsame from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:514) Do the BLAS/LAPACK libraries have a valid lsame() function with correction binding. Lion and xcode 4.2 do not Checking for functions [LSAME] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char LSAME(); static void _check_LSAME() { LSAME(); } int main() { _check_LSAME();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Defined "HAVE_LIBMKL_INTEL_LP64_DLL" to "1" Defined "HAVE_LIBMKL_INTEL_THREAD_DLL" to "1" Defined "HAVE_LIBMKL_CORE_DLL" to "1" Defined "HAVE_LIBIOMP5MD" to "1" Popping language C ================================================================================ TEST checkRuntimeIssues from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/BlasLapack.py:573) TESTING: checkRuntimeIssues from config.packages.BlasLapack(config/BuildSystem/config/packages/BlasLapack.py:573) Determines if BLAS/LAPACK routines use 32 or 64 bit integers Checking if BLAS/LAPACK routines use 32 or 64 bit integers Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif int main() { FILE *output = fopen("runtimetestoutput","w"); extern double DDOT(const int*,const double*,const int *,const double*,const int*); double x1mkl[4] = {3.0,5.0,7.0,9.0}; int one1mkl = 1,nmkl = 2; double dotresultmkl = 0; dotresultmkl = DDOT(&nmkl,x1mkl,&one1mkl,x1mkl,&one1mkl); fprintf(output, "-known-64-bit-blas-indices=%d",dotresultmkl != 34);; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.exe Popping language C Checking for 64 bit blas indices: result 0 ================================================================================ TEST checkSharedLibrary from config.packages.BlasLapack(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:799) TESTING: checkSharedLibrary from config.packages.BlasLapack(config/BuildSystem/config/package.py:799) By default we don't care about checking if the library is shared Popping language C ================================================================================ TEST alternateConfigureLibrary from config.packages.sundials(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.sundials(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.spai(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.spai(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.pARMS(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.pARMS(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.p4est(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.p4est(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default Pushing language C ================================================================================ TEST checkDependencies from config.packages.mkl_sparse_sp2m(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:721) TESTING: checkDependencies from config.packages.mkl_sparse_sp2m(config/BuildSystem/config/package.py:721) ================================================================================ TEST configureLibrary from config.packages.mkl_sparse_sp2m(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:746) TESTING: configureLibrary from config.packages.mkl_sparse_sp2m(config/BuildSystem/config/package.py:746) Find an installation and check if it can work with PETSc ================================================================================== Checking for a functional mkl_sparse_sp2m Checking for library in Compiler specific search MKL_SPARSE_SP2M: [] ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [mkl_sparse_sp2m] in library [] ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char mkl_sparse_sp2m(); static void _check_mkl_sparse_sp2m() { mkl_sparse_sp2m(); } int main() { _check_mkl_sparse_sp2m();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Popping language C Checking for headers Compiler specific search MKL_SPARSE_SP2M: [] Pushing language C ================================================================================ TEST checkInclude from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:86) TESTING: checkInclude from config.headers(config/BuildSystem/config/headers.py:86) Checks if a particular include file can be found along particular include paths Checking for header files ['mkl.h', 'mkl_spblas.h'] in [] Checking include with compiler flags var CPPFLAGS [] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 32 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_version.h" #line 16 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_version.h" #line 23 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_version.h" #line 38 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef struct _MKL_Complex8 { float real; float imag; } MKL_Complex8; typedef struct _MKL_Complex16 { double real; double imag; } MKL_Complex16; typedef struct { int MajorVersion; int MinorVersion; int UpdateVersion; char * ProductStatus; char * Build; char * Processor; char * Platform; } MKLVersion; #line 65 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 78 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 87 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 103 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 135 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 143 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef enum { MKL_ROW_MAJOR = 101, MKL_COL_MAJOR = 102 } MKL_LAYOUT; typedef enum { MKL_NOTRANS = 111, MKL_TRANS = 112, MKL_CONJTRANS = 113 } MKL_TRANSPOSE; typedef enum { MKL_UPPER = 121, MKL_LOWER = 122 } MKL_UPLO; typedef enum { MKL_NONUNIT = 131, MKL_UNIT = 132 } MKL_DIAG; typedef enum { MKL_LEFT = 141, MKL_RIGHT = 142 } MKL_SIDE; typedef enum { MKL_COMPACT_SSE = 181, MKL_COMPACT_AVX = 182, MKL_COMPACT_AVX512 = 183 } MKL_COMPACT_PACK; #line 39 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_blas.h" void XERBLA(const char *srname, const int *info, const int lsrname); int LSAME(const char *ca, const char *cb, const int lca, const int lcb); float SCABS1(const MKL_Complex8 *c); float SASUM(const int *n, const float *x, const int *incx); void SAXPY(const int *n, const float *alpha, const float *x, const int *incx, float *y, const int *incy); void SAXPBY(const int *n, const float *alpha, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SAXPYI(const int *nz, const float *a, const float *x, const int *indx,float *y); float SCASUM(const int *n, const MKL_Complex8 *x, const int *incx); float SCNRM2(const int *n, const MKL_Complex8 *x, const int *incx); void SCOPY(const int *n, const float *x, const int *incx, float *y, const int *incy); float SDOT(const int *n, const float *x, const int *incx, const float *y, const int *incy); float SDSDOT(const int *n, const float *sb, const float *x, const int *incx, const float *y, const int *incy); float SDOTI(const int *nz, const float *x, const int *indx, const float *y); void SGTHR(const int *nz, const float *y, float *x, const int *indx); void SGTHRZ(const int *nz, float *y, float *x, const int *indx); float SNRM2(const int *n, const float *x, const int *incx); void SROT(const int *n, float *x, const int *incx, float *y, const int *incy, const float *c, const float *s); void SROTG(float *a,float *b,float *c,float *s); void SROTI(const int *nz, float *x, const int *indx, float *y, const float *c, const float *s); void SROTM(const int *n, float *x, const int *incx, float *y, const int *incy, const float *param); void SROTMG(float *d1, float *d2, float *x1, const float *y1, float *param); void SSCAL(const int *n, const float *a, float *x, const int *incx); void SSCTR(const int *nz, const float *x, const int *indx, float *y); void SSWAP(const int *n, float *x, const int *incx, float *y, const int *incy); int ISAMAX(const int *n, const float *x, const int *incx); int ISAMIN(const int *n, const float *x, const int *incx); void CAXPY(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void CAXPBY(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CAXPYI(const int *nz, const MKL_Complex8 *a, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void CCOPY(const int *n, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void CDOTC(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void CDOTCI(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void CDOTU(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void CDOTUI(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void CGTHR(const int *nz, const MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void CGTHRZ(const int *nz, MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void CROTG(MKL_Complex8 *a, const MKL_Complex8 *b, float *c, MKL_Complex8 *s); void CSCAL(const int *n, const MKL_Complex8 *a, MKL_Complex8 *x, const int *incx); void CSCTR(const int *nz, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void CSROT(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy, const float *c, const float *s); void CSSCAL(const int *n, const float *a, MKL_Complex8 *x, const int *incx); void CSWAP(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); int ICAMAX(const int *n, const MKL_Complex8 *x, const int *incx); int ICAMIN(const int *n, const MKL_Complex8 *x, const int *incx); double DCABS1(const MKL_Complex16 *z); double DASUM(const int *n, const double *x, const int *incx); void DAXPY(const int *n, const double *alpha, const double *x, const int *incx, double *y, const int *incy); void DAXPBY(const int *n, const double *alpha, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DAXPYI(const int *nz, const double *a, const double *x, const int *indx, double *y); void DCOPY(const int *n, const double *x, const int *incx, double *y, const int *incy); double DDOT(const int *n, const double *x, const int *incx, const double *y, const int *incy); double DSDOT(const int *n, const float *x, const int *incx, const float *y, const int *incy); double DDOTI(const int *nz, const double *x, const int *indx, const double *y); void DGTHR(const int *nz, const double *y, double *x, const int *indx); void DGTHRZ(const int *nz, double *y, double *x, const int *indx); double DNRM2(const int *n, const double *x, const int *incx); void DROT(const int *n, double *x, const int *incx, double *y, const int *incy, const double *c, const double *s); void DROTG(double *a,double *b,double *c,double *s); void DROTI(const int *nz, double *x, const int *indx, double *y, const double *c, const double *s); void DROTM(const int *n, double *x, const int *incx, double *y, const int *incy, const double *param); void DROTMG(double *d1, double *d2, double *x1, const double *y1, double *param); void DSCAL(const int *n, const double *a, double *x, const int *incx); void DSCTR(const int *nz, const double *x, const int *indx, double *y); void DSWAP(const int *n, double *x, const int *incx, double *y, const int *incy); double DZASUM(const int *n, const MKL_Complex16 *x, const int *incx); double DZNRM2(const int *n, const MKL_Complex16 *x, const int *incx); int IDAMAX(const int *n, const double *x, const int *incx); int IDAMIN(const int *n, const double *x, const int *incx); void ZAXPY(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void ZAXPBY(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZAXPYI(const int *nz, const MKL_Complex16 *a, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void ZCOPY(const int *n, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void ZDOTC(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void ZDOTCI(MKL_Complex16 *pres,const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void ZDOTU(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void ZDOTUI(MKL_Complex16 *pres, const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void ZDROT(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy, const double *c, const double *s); void ZDSCAL(const int *n, const double *a, MKL_Complex16 *x, const int *incx); void ZGTHR(const int *nz, const MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void ZGTHRZ(const int *nz, MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void ZROTG(MKL_Complex16 *a, const MKL_Complex16 *b, double *c, MKL_Complex16 *s); void ZSCAL(const int *n, const MKL_Complex16 *a, MKL_Complex16 *x, const int *incx); void ZSCTR(const int *nz, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void ZSWAP(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); int IZAMAX(const int *n, const MKL_Complex16 *x, const int *incx); int IZAMIN(const int *n,const MKL_Complex16 *x, const int *incx); void SGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SGEMV(const char *trans, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SGER(const int *m, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void SSBMV(const char *uplo, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SSPMV(const char *uplo, const int *n, const float *alpha, const float *ap, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SSPR(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *ap); void SSPR2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *ap); void SSYMV(const char *uplo, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SSYR(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *a, const int *lda); void SSYR2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void STBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void STBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void STPMV(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void STPSV(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void STRMV(const char *uplo, const char *transa, const char *diag, const int *n, const float *a, const int *lda, float *b, const int *incx); void STRSV(const char *uplo, const char *trans, const char *diag, const int *n, const float *a, const int *lda, float *x, const int *incx); void SGEM2VU(const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x1, const int *incx1, const float *x2, const int *incx2, const float *beta, float *y1, const int *incy1, float *y2, const int *incy2); void CGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CGEMV(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CGERC(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void CGERU(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void CHBMV(const char *uplo, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CHEMV(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CHER(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *a, const int *lda); void CHER2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void CHPMV(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *ap, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CHPR(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *ap); void CHPR2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *ap); void CTBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void CTBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void CTPMV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void CTPSV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void CTRMV(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *incx); void CTRSV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void CGEM2VC(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x1, const int *incx1, const MKL_Complex8 *x2, const int *incx2, const MKL_Complex8 *beta, MKL_Complex8 *y1, const int *incy1, MKL_Complex8 *y2, const int *incy2); void SCGEMV(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void DGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DGEMV(const char *trans, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DGER(const int *m, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void DSBMV(const char *uplo, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DSPMV(const char *uplo, const int *n, const double *alpha, const double *ap, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DSPR(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *ap); void DSPR2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *ap); void DSYMV(const char *uplo, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DSYR(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *a, const int *lda); void DSYR2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void DTBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void DTBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void DTPMV(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void DTPSV(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void DTRMV(const char *uplo, const char *transa, const char *diag, const int *n, const double *a, const int *lda, double *b, const int *incx); void DTRSV(const char *uplo, const char *trans, const char *diag, const int *n, const double *a, const int *lda, double *x, const int *incx); void DGEM2VU(const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x1, const int *incx1, const double *x2, const int *incx2, const double *beta, double *y1, const int *incy1, double *y2, const int *incy2); void ZGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZGEMV(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZGERC(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void ZGERU(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void ZHBMV(const char *uplo, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZHEMV(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZHER(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *a, const int *lda); void ZHER2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void ZHPMV(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *ap, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZHPR(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *ap); void ZHPR2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *ap); void ZTBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ZTBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ZTPMV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ZTPSV(const char *uplo, const char *trans, const char *diag, const int *n, MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ZTRMV(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *incx); void ZTRSV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ZGEM2VC(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x1, const int *incx1, const MKL_Complex16 *x2, const int *incx2, const MKL_Complex16 *beta, MKL_Complex16 *y1, const int *incy1, MKL_Complex16 *y2, const int *incy2); void DZGEMV(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void SGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); float* SGEMM_ALLOC(const char *identifier, const int *m, const int *n, const int *k); void SGEMM_PACK(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const float *alpha, const float *src, const int *ld, float *dest); void SGEMM_COMPUTE(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SGEMM_FREE(float *mat); void SGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const float *alpha_array, const float **a_array, const int *lda_array, const float **b_array, const int *ldb_array, const float *beta_array, float **c_array, const int *ldc_array, const int *group_count, const int *group_size); void SGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SSYMM(const char *side, const char *uplo, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SSYRK(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *beta, float *c, const int *ldc); void STRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void STRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void STRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const float *alpha_array, const float **a_array, const int *lda_array, float **b_array, const int *ldb, const int *group_count, const int *group_size); void CGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void SCGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CGEMM3M(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CGEMM3M_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void CGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CHEMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CHER2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const float *beta, MKL_Complex8 *c, const int *ldc); void CHERK(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const MKL_Complex8 *a, const int *lda, const float *beta, MKL_Complex8 *c, const int *ldc); void CSYMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CSYRK(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CTRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void CTRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void CTRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, MKL_Complex8 **b_array, const int *ldb, const int *group_count, const int *group_size); void DGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); double* DGEMM_ALLOC(const char *identifier, const int *m, const int *n, const int *k); void DGEMM_PACK(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const double *alpha, const double *src, const int *ld, double *dest); void DGEMM_COMPUTE(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void DGEMM_FREE(double *mat); void DGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const double *alpha_array, const double **a_array, const int *lda_array, const double **b_array, const int *ldb_array, const double *beta_array, double **c_array, const int *ldc_array, const int *group_count, const int *group_size); void DGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, double *beta, double *c, const int *ldc); void DSYMM(const char *side, const char *uplo, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void DSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, double *beta, double *c, const int *ldc); void DSYRK(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *beta, double *c, const int *ldc); void DTRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void DTRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void DTRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const double *alpha_array, const double **a_array, const int *lda_array, double **b_array, const int *ldb, const int *group_count, const int *group_size); void ZGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void DZGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZGEMM3M(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZGEMM3M_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void ZGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZHEMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZHER2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const double *beta, MKL_Complex16 *c, const int *ldc); void ZHERK(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const MKL_Complex16 *a, const int *lda, const double *beta, MKL_Complex16 *c, const int *ldc); void ZSYMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZSYRK(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZTRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ZTRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ZTRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, MKL_Complex16 **b_array, const int *ldb, const int *group_count, const int *group_size); void GEMM_S8U8S32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const char *a, const int *lda, const char *ao, const unsigned char *b, const int *ldb, const char *bo, const float *beta, int *c, const int *ldc, const int *co); void GEMM_S16S16S32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const short *a, const int *lda, const short *ao, const short *b, const int *ldb, const short *bo, const float *beta, int *c, const int *ldc, const int *co); void xerbla(const char *srname, const int *info, const int lsrname); int lsame(const char *ca, const char *cb, const int lca, const int lcb); float scabs1(const MKL_Complex8 *c); float sasum(const int *n, const float *x, const int *incx); void saxpy(const int *n, const float *alpha, const float *x, const int *incx, float *y, const int *incy); void saxpby(const int *n, const float *alpha, const float *x, const int *incx, const float *beta, float *y, const int *incy); void saxpyi(const int *nz, const float *a, const float *x, const int *indx, float *y); float scasum(const int *n, const MKL_Complex8 *x, const int *incx); float scnrm2(const int *n, const MKL_Complex8 *x, const int *incx); void scopy(const int *n, const float *x, const int *incx, float *y, const int *incy); float sdot(const int *n, const float *x, const int *incx, const float *y, const int *incy); float sdoti(const int *nz, const float *x, const int *indx, const float *y); float sdsdot(const int *n, const float *sb, const float *x, const int *incx, const float *y, const int *incy); void sgthr(const int *nz, const float *y, float *x, const int *indx); void sgthrz(const int *nz, float *y, float *x, const int *indx); float snrm2(const int *n, const float *x, const int *incx); void srot(const int *n, float *x, const int *incx, float *y, const int *incy, const float *c, const float *s); void srotg(float *a,float *b,float *c,float *s); void sroti(const int *nz, float *x, const int *indx, float *y, const float *c, const float *s); void srotm(const int *n, float *x, const int *incx, float *y, const int *incy, const float *param); void srotmg(float *d1, float *d2, float *x1, const float *y1, float *param); void sscal(const int *n, const float *a, float *x, const int *incx); void ssctr(const int *nz, const float *x, const int *indx, float *y); void sswap(const int *n, float *x, const int *incx, float *y, const int *incy); int isamax(const int *n, const float *x, const int *incx); int isamin(const int *n, const float *x, const int *incx); void caxpy(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void caxpby(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void caxpyi(const int *nz, const MKL_Complex8 *a, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void ccopy(const int *n, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void cdotc(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void cdotci(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void cdotu(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void cdotui(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void cgthr(const int *nz, const MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void cgthrz(const int *nz, MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void crotg(MKL_Complex8 *a, const MKL_Complex8 *b, float *c, MKL_Complex8 *s); void cscal(const int *n, const MKL_Complex8 *a, MKL_Complex8 *x, const int *incx); void csctr(const int *nz, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void csrot(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy, const float *c, const float *s); void csscal(const int *n, const float *a, MKL_Complex8 *x, const int *incx); void cswap(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); int icamax(const int *n, const MKL_Complex8 *x, const int *incx); int icamin(const int *n, const MKL_Complex8 *x, const int *incx); double dcabs1(const MKL_Complex16 *z); double dasum(const int *n, const double *x, const int *incx); void daxpy(const int *n, const double *alpha, const double *x, const int *incx, double *y, const int *incy); void daxpby(const int *n, const double *alpha, const double *x, const int *incx, const double *beta, double *y, const int *incy); void daxpyi(const int *nz, const double *a, const double *x, const int *indx, double *y); void dcopy(const int *n, const double *x, const int *incx, double *y, const int *incy); double ddot(const int *n, const double *x, const int *incx, const double *y, const int *incy); double dsdot(const int *n, const float *x, const int *incx, const float *y, const int *incy); double ddoti(const int *nz, const double *x, const int *indx, const double *y); void dgthr(const int *nz, const double *y, double *x, const int *indx); void dgthrz(const int *nz, double *y, double *x, const int *indx); double dnrm2(const int *n, const double *x, const int *incx); void drot(const int *n, double *x, const int *incx, double *y, const int *incy, const double *c, const double *s); void drotg(double *a, double *b, double *c, double *s); void droti(const int *nz, double *x, const int *indx, double *y, const double *c, const double *s); void drotm(const int *n, double *x, const int *incx, double *y, const int *incy, const double *param); void drotmg(double *d1, double *d2, double *x1, const double *y1, double *param); void dscal(const int *n, const double *a, double *x, const int *incx); void dsctr(const int *nz, const double *x, const int *indx, double *y); void dswap(const int *n, double *x, const int *incx, double *y, const int *incy); double dzasum(const int *n, const MKL_Complex16 *x, const int *incx); double dznrm2(const int *n, const MKL_Complex16 *x, const int *incx); int idamax(const int *n, const double *x, const int *incx); int idamin(const int *n, const double *x, const int *incx); void zaxpy(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void zaxpby(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zaxpyi(const int *nz, const MKL_Complex16 *a, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void zcopy(const int *n, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void zdotc(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void zdotci(MKL_Complex16 *pres, const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void zdotu(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void zdotui(MKL_Complex16 *pres, const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void zdrot(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy, const double *c, const double *s); void zdscal(const int *n, const double *a, MKL_Complex16 *x, const int *incx); void zgthr(const int *nz, const MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void zgthrz(const int *nz, MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void zrotg(MKL_Complex16 *a, const MKL_Complex16 *b, double *c, MKL_Complex16 *s); void zscal(const int *n, const MKL_Complex16 *a, MKL_Complex16 *x, const int *incx); void zsctr(const int *nz, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void zswap(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); int izamax(const int *n, const MKL_Complex16 *x, const int *incx); int izamin(const int *n, const MKL_Complex16 *x, const int *incx); void sgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sgemv(const char *trans, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sger(const int *m, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void ssbmv(const char *uplo, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sspmv(const char *uplo, const int *n, const float *alpha, const float *ap, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sspr(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *ap); void sspr2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *ap); void ssymv(const char *uplo, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void ssyr(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *a, const int *lda); void ssyr2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void stbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void stbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void stpmv(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void stpsv(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void strmv(const char *uplo, const char *transa, const char *diag, const int *n, const float *a, const int *lda, float *b, const int *incx); void strsv(const char *uplo, const char *trans, const char *diag, const int *n, const float *a, const int *lda, float *x, const int *incx); void sgem2vu(const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x1, const int *incx1, const float *x2, const int *incx2, const float *beta, float *y1, const int *incy1, float *y2, const int *incy2); void cgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void cgemv(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void cgerc(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void cgeru(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void chbmv(const char *uplo, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void chemv(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void cher(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *a, const int *lda); void cher2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void chpmv(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *ap, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void chpr(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *ap); void chpr2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *ap); void ctbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void ctbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void ctpmv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void ctpsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void ctrmv(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *incx); void ctrsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void cgem2vc(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x1, const int *incx1, const MKL_Complex8 *x2, const int *incx2, const MKL_Complex8 *beta, MKL_Complex8 *y1, const int *incy1, MKL_Complex8 *y2, const int *incy2); void scgemv(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void dgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dgemv(const char *trans, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dger(const int *m, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void dsbmv(const char *uplo, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dspmv(const char *uplo, const int *n, const double *alpha, const double *ap, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dspr(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *ap); void dspr2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *ap); void dsymv(const char *uplo, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dsyr(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *a, const int *lda); void dsyr2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void dtbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void dtbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void dtpmv(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void dtpsv(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void dtrmv(const char *uplo, const char *transa, const char *diag, const int *n, const double *a, const int *lda, double *b, const int *incx); void dtrsv(const char *uplo, const char *trans, const char *diag, const int *n, const double *a, const int *lda, double *x, const int *incx); void dgem2vu(const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x1, const int *incx1, const double *x2, const int *incx2, const double *beta, double *y1, const int *incy1, double *y2, const int *incy2); void zgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zgemv(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zgerc(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void zgeru(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void zhbmv(const char *uplo, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zhemv(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zher(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *a, const int *lda); void zher2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void zhpmv(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *ap, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zhpr(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *ap); void zhpr2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *ap); void ztbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ztbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ztpmv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ztpsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ztrmv(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *incx); void ztrsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void zgem2vc(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x1, const int *incx1, const MKL_Complex16 *x2, const int *incx2, const MKL_Complex16 *beta, MKL_Complex16 *y1, const int *incy1, MKL_Complex16 *y2, const int *incy2); void dzgemv(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void sgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); float* sgemm_alloc(const char *identifier, const int *m, const int *n, const int *k); void sgemm_pack(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const float *alpha, const float *src, const int *ld, float *dest); void sgemm_compute(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void sgemm_free(float *mat); void sgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const float *alpha_array, const float **a_array, const int *lda_array, const float **b_array, const int *ldb_array, const float *beta_array, float **c_array, const int *ldc_array, const int *group_count, const int *group_size); void sgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void ssymm(const char *side, const char *uplo, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void ssyr2k(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void ssyrk(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *beta, float *c, const int *ldc); void strmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void strsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void strsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const float *alpha_array, const float **a_array, const int *lda_array, float **b_array, const int *ldb, const int *group_count, const int *group_size); void cgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void scgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cgemm3m(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cgemm3m_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void cgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void chemm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cher2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const float *beta, MKL_Complex8 *c, const int *ldc); void cherk(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const MKL_Complex8 *a, const int *lda, const float *beta, MKL_Complex8 *c, const int *ldc); void csymm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void csyr2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void csyrk(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void ctrmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void ctrsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void ctrsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, MKL_Complex8 **b_array, const int *ldb, const int *group_count, const int *group_size); void dgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); double* dgemm_alloc(const char *identifier, const int *m, const int *n, const int *k); void dgemm_pack(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const double *alpha, const double *src, const int *ld, double *dest); void dgemm_compute(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dgemm_free(double *mat); void dgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const double *alpha_array, const double **a_array, const int *lda_array, const double **b_array, const int *ldb_array, const double *beta_array, double **c_array, const int *ldc_array, const int *group_count, const int *group_size); void dgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dsymm(const char *side, const char *uplo, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dsyr2k(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dsyrk(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *beta, double *c, const int *ldc); void dtrmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void dtrsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void dtrsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const double *alpha_array, const double **a_array, const int *lda_array, double **b_array, const int *ldb, const int *group_count, const int *group_size); void zgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void dzgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zgemm3m(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zgemm3m_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void zgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zhemm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zher2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const double *beta, MKL_Complex16 *c, const int *ldc); void zherk(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const MKL_Complex16 *a, const int *lda, const double *beta, MKL_Complex16 *c, const int *ldc); void zsymm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zsyr2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zsyrk(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ztrmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ztrsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ztrsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, MKL_Complex16 **b_array, const int *ldb, const int *group_count, const int *group_size); void gemm_s8u8s32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const char *a, const int *lda, const char *ao, const unsigned char *b, const int *ldb, const char *bo, const float *beta, int *c, const int *ldc, const int *co); void gemm_s16s16s32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const short *a, const int *lda, const short *ao, const short *b, const int *ldb, const short *bo, const float *beta, int *c, const int *ldc, const int *co); #line 40 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_trans.h" void MKL_Simatcopy( const char ordering, const char trans, size_t rows, size_t cols, const float alpha, float * AB, size_t lda, size_t ldb); void MKL_Dimatcopy( const char ordering, const char trans, size_t rows, size_t cols, const double alpha, double * AB, size_t lda, size_t ldb); void MKL_Cimatcopy( const char ordering, const char trans, size_t rows, size_t cols, const MKL_Complex8 alpha, MKL_Complex8 * AB, size_t lda, size_t ldb); void MKL_Zimatcopy( const char ordering, const char trans, size_t rows, size_t cols, const MKL_Complex16 alpha, MKL_Complex16 * AB, size_t lda, size_t ldb); void MKL_Somatcopy( char ordering, char trans, size_t rows, size_t cols, const float alpha, const float * A, size_t lda, float * B, size_t ldb); void MKL_Domatcopy( char ordering, char trans, size_t rows, size_t cols, const double alpha, const double * A, size_t lda, double * B, size_t ldb); void MKL_Comatcopy( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex8 alpha, const MKL_Complex8 * A, size_t lda, MKL_Complex8 * B, size_t ldb); void MKL_Zomatcopy( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex16 alpha, const MKL_Complex16 * A, size_t lda, MKL_Complex16 * B, size_t ldb); void MKL_Somatcopy2( char ordering, char trans, size_t rows, size_t cols, const float alpha, const float * A, size_t lda, size_t stridea, float * B, size_t ldb, size_t strideb); void MKL_Domatcopy2( char ordering, char trans, size_t rows, size_t cols, const double alpha, const double * A, size_t lda, size_t stridea, double * B, size_t ldb, size_t strideb); void MKL_Comatcopy2( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex8 alpha, const MKL_Complex8 * A, size_t lda, size_t stridea, MKL_Complex8 * B, size_t ldb, size_t strideb); void MKL_Zomatcopy2( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex16 alpha, const MKL_Complex16 * A, size_t lda, size_t stridea, MKL_Complex16 * B, size_t ldb, size_t strideb); void MKL_Somatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const float alpha, const float * A, size_t lda, const float beta, const float * B, size_t ldb, float * C, size_t ldc); void MKL_Domatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const double alpha, const double * A, size_t lda, const double beta, const double * B, size_t ldb, double * C, size_t ldc); void MKL_Comatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const MKL_Complex8 alpha, const MKL_Complex8 * A, size_t lda, const MKL_Complex8 beta, const MKL_Complex8 * B, size_t ldb, MKL_Complex8 * C, size_t ldc); void MKL_Zomatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const MKL_Complex16 alpha, const MKL_Complex16 * A, size_t lda, const MKL_Complex16 beta, const MKL_Complex16 * B, size_t ldb, MKL_Complex16 * C, size_t ldc); #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_cblas.h" #line 37 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_cblas.h" typedef enum {CblasRowMajor=101, CblasColMajor=102} CBLAS_LAYOUT; typedef enum {CblasNoTrans=111, CblasTrans=112, CblasConjTrans=113} CBLAS_TRANSPOSE; typedef enum {CblasUpper=121, CblasLower=122} CBLAS_UPLO; typedef enum {CblasNonUnit=131, CblasUnit=132} CBLAS_DIAG; typedef enum {CblasLeft=141, CblasRight=142} CBLAS_SIDE; typedef enum {CblasPacked=151} CBLAS_STORAGE; typedef enum {CblasAMatrix=161, CblasBMatrix=162} CBLAS_IDENTIFIER; typedef enum {CblasRowOffset=171, CblasColOffset=172, CblasFixOffset=173} CBLAS_OFFSET; typedef CBLAS_LAYOUT CBLAS_ORDER; double cblas_dcabs1(const void *z); float cblas_scabs1(const void *c); float cblas_sdot(const int N, const float *X, const int incX, const float *Y, const int incY); float cblas_sdoti(const int N, const float *X, const int *indx, const float *Y); double cblas_ddot(const int N, const double *X, const int incX, const double *Y, const int incY); double cblas_ddoti(const int N, const double *X, const int *indx, const double *Y); double cblas_dsdot(const int N, const float *X, const int incX, const float *Y, const int incY); float cblas_sdsdot(const int N, const float sb, const float *X, const int incX, const float *Y, const int incY); void cblas_cdotu_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotu); void cblas_cdotui_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); void cblas_cdotc_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotc); void cblas_cdotci_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); void cblas_zdotu_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotu); void cblas_zdotui_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); void cblas_zdotc_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotc); void cblas_zdotci_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); float cblas_snrm2(const int N, const float *X, const int incX); float cblas_sasum(const int N, const float *X, const int incX); double cblas_dnrm2(const int N, const double *X, const int incX); double cblas_dasum(const int N, const double *X, const int incX); float cblas_scnrm2(const int N, const void *X, const int incX); float cblas_scasum(const int N, const void *X, const int incX); double cblas_dznrm2(const int N, const void *X, const int incX); double cblas_dzasum(const int N, const void *X, const int incX); size_t cblas_isamax(const int N, const float *X, const int incX); size_t cblas_idamax(const int N, const double *X, const int incX); size_t cblas_icamax(const int N, const void *X, const int incX); size_t cblas_izamax(const int N, const void *X, const int incX); size_t cblas_isamin(const int N, const float *X, const int incX); size_t cblas_idamin(const int N, const double *X, const int incX); size_t cblas_icamin(const int N, const void *X, const int incX); size_t cblas_izamin(const int N, const void *X, const int incX); void cblas_sswap(const int N, float *X, const int incX, float *Y, const int incY); void cblas_scopy(const int N, const float *X, const int incX, float *Y, const int incY); void cblas_saxpy(const int N, const float alpha, const float *X, const int incX, float *Y, const int incY); void cblas_saxpby(const int N, const float alpha, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_saxpyi(const int N, const float alpha, const float *X, const int *indx, float *Y); void cblas_sgthr(const int N, const float *Y, float *X, const int *indx); void cblas_sgthrz(const int N, float *Y, float *X, const int *indx); void cblas_ssctr(const int N, const float *X, const int *indx, float *Y); void cblas_srotg(float *a, float *b, float *c, float *s); void cblas_dswap(const int N, double *X, const int incX, double *Y, const int incY); void cblas_dcopy(const int N, const double *X, const int incX, double *Y, const int incY); void cblas_daxpy(const int N, const double alpha, const double *X, const int incX, double *Y, const int incY); void cblas_daxpby(const int N, const double alpha, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_daxpyi(const int N, const double alpha, const double *X, const int *indx, double *Y); void cblas_dgthr(const int N, const double *Y, double *X, const int *indx); void cblas_dgthrz(const int N, double *Y, double *X, const int *indx); void cblas_dsctr(const int N, const double *X, const int *indx, double *Y); void cblas_drotg(double *a, double *b, double *c, double *s); void cblas_cswap(const int N, void *X, const int incX, void *Y, const int incY); void cblas_ccopy(const int N, const void *X, const int incX, void *Y, const int incY); void cblas_caxpy(const int N, const void *alpha, const void *X, const int incX, void *Y, const int incY); void cblas_caxpby(const int N, const void *alpha, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_caxpyi(const int N, const void *alpha, const void *X, const int *indx, void *Y); void cblas_cgthr(const int N, const void *Y, void *X, const int *indx); void cblas_cgthrz(const int N, void *Y, void *X, const int *indx); void cblas_csctr(const int N, const void *X, const int *indx, void *Y); void cblas_crotg(void *a, const void *b, float *c, void *s); void cblas_zswap(const int N, void *X, const int incX, void *Y, const int incY); void cblas_zcopy(const int N, const void *X, const int incX, void *Y, const int incY); void cblas_zaxpy(const int N, const void *alpha, const void *X, const int incX, void *Y, const int incY); void cblas_zaxpby(const int N, const void *alpha, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zaxpyi(const int N, const void *alpha, const void *X, const int *indx, void *Y); void cblas_zgthr(const int N, const void *Y, void *X, const int *indx); void cblas_zgthrz(const int N, void *Y, void *X, const int *indx); void cblas_zsctr(const int N, const void *X, const int *indx, void *Y); void cblas_zrotg(void *a, const void *b, double *c, void *s); void cblas_srotmg(float *d1, float *d2, float *b1, const float b2, float *P); void cblas_srot(const int N, float *X, const int incX, float *Y, const int incY, const float c, const float s); void cblas_sroti(const int N, float *X, const int *indx, float *Y, const float c, const float s); void cblas_srotm(const int N, float *X, const int incX, float *Y, const int incY, const float *P); void cblas_drotmg(double *d1, double *d2, double *b1, const double b2, double *P); void cblas_drot(const int N, double *X, const int incX, double *Y, const int incY, const double c, const double s); void cblas_drotm(const int N, double *X, const int incX, double *Y, const int incY, const double *P); void cblas_droti(const int N, double *X, const int *indx, double *Y, const double c, const double s); void cblas_csrot(const int N, void *X, const int incX, void *Y, const int incY, const float c, const float s); void cblas_zdrot(const int N, void *X, const int incX, void *Y, const int incY, const double c, const double s); void cblas_sscal(const int N, const float alpha, float *X, const int incX); void cblas_dscal(const int N, const double alpha, double *X, const int incX); void cblas_cscal(const int N, const void *alpha, void *X, const int incX); void cblas_zscal(const int N, const void *alpha, void *X, const int incX); void cblas_csscal(const int N, const float alpha, void *X, const int incX); void cblas_zdscal(const int N, const double alpha, void *X, const int incX); void cblas_sgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_sgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_strmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *A, const int lda, float *X, const int incX); void cblas_stbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const float *A, const int lda, float *X, const int incX); void cblas_stpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *Ap, float *X, const int incX); void cblas_strsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *A, const int lda, float *X, const int incX); void cblas_stbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const float *A, const int lda, float *X, const int incX); void cblas_stpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *Ap, float *X, const int incX); void cblas_dgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dtrmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *A, const int lda, double *X, const int incX); void cblas_dtbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const double *A, const int lda, double *X, const int incX); void cblas_dtpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *Ap, double *X, const int incX); void cblas_dtrsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *A, const int lda, double *X, const int incX); void cblas_dtbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const double *A, const int lda, double *X, const int incX); void cblas_dtpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *Ap, double *X, const int incX); void cblas_cgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_cgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_ctrmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ctbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ctpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_ctrsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ctbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ctpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_zgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_ztrmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ztbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ztpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_ztrsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ztbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ztpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_ssymv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_ssbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_sspmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *Ap, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_sger(const CBLAS_LAYOUT Layout, const int M, const int N, const float alpha, const float *X, const int incX, const float *Y, const int incY, float *A, const int lda); void cblas_ssyr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, float *A, const int lda); void cblas_sspr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, float *Ap); void cblas_ssyr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, const float *Y, const int incY, float *A, const int lda); void cblas_sspr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, const float *Y, const int incY, float *A); void cblas_dsymv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dsbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dspmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *Ap, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dger(const CBLAS_LAYOUT Layout, const int M, const int N, const double alpha, const double *X, const int incX, const double *Y, const int incY, double *A, const int lda); void cblas_dsyr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, double *A, const int lda); void cblas_dspr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, double *Ap); void cblas_dsyr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, const double *Y, const int incY, double *A, const int lda); void cblas_dspr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, const double *Y, const int incY, double *A); void cblas_chemv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_chbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_chpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *Ap, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_cgeru(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_cgerc(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_cher(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const void *X, const int incX, void *A, const int lda); void cblas_chpr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const void *X, const int incX, void *A); void cblas_cher2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_chpr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *Ap); void cblas_zhemv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zhbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zhpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *Ap, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zgeru(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_zgerc(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_zher(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const void *X, const int incX, void *A, const int lda); void cblas_zhpr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const void *X, const int incX, void *A); void cblas_zher2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_zhpr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *Ap); void cblas_sgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_sgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const float *alpha_Array, const float **A_Array, const int *lda_Array, const float **B_Array, const int *ldb_Array, const float *beta_Array, float **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_sgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_ssymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_ssyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const float alpha, const float *A, const int lda, const float beta, float *C, const int ldc); void cblas_ssyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_strmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const float alpha, const float *A, const int lda, float *B, const int ldb); void cblas_strsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const float alpha, const float *A, const int lda, float *B, const int ldb); void cblas_strsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const float *alpha_Array, const float **A_Array, const int *lda_Array, float **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_dgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const double *alpha_Array, const double **A_Array, const int *lda_Array, const double **B_Array, const int* ldb_Array, const double *beta_Array, double **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_dgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dsymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dsyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const double alpha, const double *A, const int lda, const double beta, double *C, const int ldc); void cblas_dsyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dtrmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const double alpha, const double *A, const int lda, double *B, const int ldb); void cblas_dtrsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const double alpha, const double *A, const int lda, double *B, const int ldb); void cblas_dtrsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *Transa_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const double *alpha_Array, const double **A_Array, const int *lda_Array, double **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_cgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_cgemm3m(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_cgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_cgemm3m_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_cgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_csymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_csyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *beta, void *C, const int ldc); void cblas_csyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_ctrmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ctrsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ctrsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *Transa_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, void **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_zgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zgemm3m(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_zgemm3m_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_zgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zsymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zsyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *beta, void *C, const int ldc); void cblas_zsyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_ztrmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ztrsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ztrsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *Transa_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, void **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_chemm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_cherk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const float alpha, const void *A, const int lda, const float beta, void *C, const int ldc); void cblas_cher2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const float beta, void *C, const int ldc); void cblas_zhemm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zherk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const double alpha, const void *A, const int lda, const double beta, void *C, const int ldc); void cblas_zher2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const double beta, void *C, const int ldc); __declspec(dllexport) float* cblas_sgemm_alloc(const CBLAS_IDENTIFIER identifier, const int M, const int N, const int K); void cblas_sgemm_pack(const CBLAS_LAYOUT Layout, const CBLAS_IDENTIFIER identifier, const CBLAS_TRANSPOSE Trans, const int M, const int N, const int K, const float alpha, const float *src, const int ld, float *dest); void cblas_sgemm_compute(const CBLAS_LAYOUT Layout, const int TransA, const int TransB, const int M, const int N, const int K, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_sgemm_free(float *dest); __declspec(dllexport) double* cblas_dgemm_alloc(const CBLAS_IDENTIFIER identifier, const int M, const int N, const int K); void cblas_dgemm_pack(const CBLAS_LAYOUT Layout, const CBLAS_IDENTIFIER identifier, const CBLAS_TRANSPOSE Trans, const int M, const int N, const int K, const double alpha, const double *src, const int ld, double *dest); void cblas_dgemm_compute(const CBLAS_LAYOUT Layout, const int TransA, const int TransB, const int M, const int N, const int K, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dgemm_free(double *dest); void cblas_gemm_s16s16s32(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const CBLAS_OFFSET OffsetC, const int M, const int N, const int K, const float alpha, const short *A, const int lda, const short ao, const short *B, const int ldb, const short bo, const float beta, int *C, const int ldc, const int *cb); void cblas_gemm_s8u8s32(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const CBLAS_OFFSET OffsetC, const int M, const int N, const int K, const float alpha, const void *A, const int lda, const char ao, const void *B, const int ldb, const char bo, const float beta, int *C, const int ldc, const int *cb); #line 42 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" #line 35 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" __declspec(deprecated) void mkl_scsrmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scsrsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scscmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scscsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scoomv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scoosv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_sdiamv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sdiasv (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiagemv(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiasymv(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sskymv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sskysv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void mkl_sbsrmv (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sbsrsv(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scsrsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scscmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scscsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scoomm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scoosm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiamm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiasm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskysm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskymm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrsm(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSRSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSCMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSCSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCOOMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCOOSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SDIAMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SDIASV (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIAGEMV(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIASYMV(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SSKYMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SSKYSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void MKL_SBSRMV (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SBSRSV(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIAMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIASM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYSM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRSM(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_dcsrmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcsrsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcscmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcscsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcoomv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcoosv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_ddiamv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_ddiasv (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiagemv(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiasymv(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_dskymv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dskysv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void mkl_dbsrmv (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dbsrsv(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcsrsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoomm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoosm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiamm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiasm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskysm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskymm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrsm(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSRSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSCMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSCSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCOOMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCOOSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DDIAMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DDIASV (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIAGEMV(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIASYMV(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DSKYMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DSKYSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void MKL_DBSRMV (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DBSRSV(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIAMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIASM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYSM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRSM(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ccsrmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoomv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiamv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasv (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiagemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskymv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskysv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccsrsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoosm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiasm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskysm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASV (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIASM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoomv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiamv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasv (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiagemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskymv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskysv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoosm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiasm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskysm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASV (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIASM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_dcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_dcsrcoo(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_ddnscsr(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_dcsrcsc(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_dcsrdia(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_dcsrsky(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_scsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_scsrcoo(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_sdnscsr(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_scsrcsc(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_scsrdia(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_scsrsky(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_ccsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_ccsrcoo(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_cdnscsr(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_ccsrcsc(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_ccsrdia(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_ccsrsky(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_zcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_zcsrcoo(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_zdnscsr(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_zcsrcsc(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_zcsrdia(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_zcsrsky(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_DCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_DCSRCOO(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_DDNSCSR(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_DCSRCSC(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_DCSRDIA(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_DCSRSKY(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_SCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_SCSRCOO(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_SDNSCSR(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_SCSRCSC(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_SCSRDIA(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_SCSRSKY(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_CCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_CCSRCOO(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_CDNSCSR(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_CCSRCSC(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_CCSRDIA(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_CCSRSKY(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_ZCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_ZCSRCOO(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_ZDNSCSR(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_ZCSRCSC(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_ZCSRDIA(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_ZCSRSKY(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_dcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_dcsrmultd(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void mkl_dcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultd(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void mkl_scsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void mkl_ccsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void mkl_zcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTD(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void MKL_DCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTD(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void MKL_SCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void MKL_CCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void MKL_ZCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); typedef enum { SPARSE_STATUS_SUCCESS = 0, SPARSE_STATUS_NOT_INITIALIZED = 1, SPARSE_STATUS_ALLOC_FAILED = 2, SPARSE_STATUS_INVALID_VALUE = 3, SPARSE_STATUS_EXECUTION_FAILED = 4, SPARSE_STATUS_INTERNAL_ERROR = 5, SPARSE_STATUS_NOT_SUPPORTED = 6 } sparse_status_t; typedef enum { SPARSE_OPERATION_NON_TRANSPOSE = 10, SPARSE_OPERATION_TRANSPOSE = 11, SPARSE_OPERATION_CONJUGATE_TRANSPOSE = 12 } sparse_operation_t; typedef enum { SPARSE_MATRIX_TYPE_GENERAL = 20, SPARSE_MATRIX_TYPE_SYMMETRIC = 21, SPARSE_MATRIX_TYPE_HERMITIAN = 22, SPARSE_MATRIX_TYPE_TRIANGULAR = 23, SPARSE_MATRIX_TYPE_DIAGONAL = 24, SPARSE_MATRIX_TYPE_BLOCK_TRIANGULAR = 25, SPARSE_MATRIX_TYPE_BLOCK_DIAGONAL = 26 } sparse_matrix_type_t; typedef enum { SPARSE_INDEX_BASE_ZERO = 0, SPARSE_INDEX_BASE_ONE = 1 } sparse_index_base_t; typedef enum { SPARSE_FILL_MODE_LOWER = 40, SPARSE_FILL_MODE_UPPER = 41, SPARSE_FILL_MODE_FULL = 42 } sparse_fill_mode_t; typedef enum { SPARSE_DIAG_NON_UNIT = 50, SPARSE_DIAG_UNIT = 51 } sparse_diag_type_t; typedef enum { SPARSE_LAYOUT_ROW_MAJOR = 101, SPARSE_LAYOUT_COLUMN_MAJOR = 102 } sparse_layout_t; typedef enum { SPARSE_VERBOSE_OFF = 70, SPARSE_VERBOSE_BASIC = 71, SPARSE_VERBOSE_EXTENDED = 72 } verbose_mode_t; typedef enum { SPARSE_MEMORY_NONE = 80, SPARSE_MEMORY_AGGRESSIVE = 81 } sparse_memory_usage_t; typedef enum { SPARSE_STAGE_FULL_MULT = 90, SPARSE_STAGE_NNZ_COUNT = 91, SPARSE_STAGE_FINALIZE_MULT = 92, SPARSE_STAGE_FULL_MULT_NO_VAL = 93, SPARSE_STAGE_FINALIZE_MULT_NO_VAL = 94 } sparse_request_t; struct sparse_matrix; typedef struct sparse_matrix *sparse_matrix_t; struct matrix_descr { sparse_matrix_type_t type; sparse_fill_mode_t mode; sparse_diag_type_t diag; }; sparse_status_t mkl_sparse_s_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_copy( const sparse_matrix_t source, struct matrix_descr descr, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_destroy( sparse_matrix_t A ); sparse_status_t mkl_sparse_get_error_info( sparse_matrix_t A, int *info ); sparse_status_t mkl_sparse_convert_csr ( const sparse_matrix_t source, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_convert_bsr ( const sparse_matrix_t source, int block_size, sparse_layout_t block_layout, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_s_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_set_value( sparse_matrix_t A, int row, int col, float value ); sparse_status_t mkl_sparse_d_set_value( sparse_matrix_t A, int row, int col, double value ); sparse_status_t mkl_sparse_c_set_value( sparse_matrix_t A, int row, int col, MKL_Complex8 value ); sparse_status_t mkl_sparse_z_set_value( sparse_matrix_t A, int row, int col, MKL_Complex16 value ); sparse_status_t mkl_sparse_set_verbose_mode ( verbose_mode_t verbose ); sparse_status_t mkl_sparse_set_mv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_mm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_sv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_sm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_memory_hint ( sparse_matrix_t A, sparse_memory_usage_t policy ); sparse_status_t mkl_sparse_optimize ( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_mv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y ); sparse_status_t mkl_sparse_d_mv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y ); sparse_status_t mkl_sparse_c_mv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_mv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_trsv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float *y ); sparse_status_t mkl_sparse_d_trsv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double *y ); sparse_status_t mkl_sparse_c_trsv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_trsv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_mm( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float beta, float *y, int ldy ); sparse_status_t mkl_sparse_d_mm( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double beta, double *y, int ldy ); sparse_status_t mkl_sparse_c_mm( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 beta, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_mm( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 beta, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_trsm ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float *y, int ldy ); sparse_status_t mkl_sparse_d_trsm ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double *y, int ldy ); sparse_status_t mkl_sparse_c_trsm ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_trsm ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_add( sparse_operation_t operation, const sparse_matrix_t A, float alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_d_add( sparse_operation_t operation, const sparse_matrix_t A, double alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_c_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_z_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_spmm( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sp2m ( sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, sparse_request_t request, sparse_matrix_t *C ); sparse_status_t mkl_sparse_syrk ( sparse_operation_t operation, const sparse_matrix_t A, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sypr ( sparse_operation_t transA, const sparse_matrix_t A, const sparse_matrix_t B, struct matrix_descr descrB, sparse_matrix_t *C, sparse_request_t request ); sparse_status_t mkl_sparse_s_syprd ( const sparse_operation_t op, const sparse_matrix_t A, float *B, const sparse_layout_t layoutB, const int ldb, float alpha, float beta, float *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_d_syprd ( const sparse_operation_t op, const sparse_matrix_t A, double *B, const sparse_layout_t layoutB, const int ldb, double alpha, double beta, double *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_c_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex8 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_z_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex16 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_order( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, float *C, int ldc ); sparse_status_t mkl_sparse_d_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, double *C, int ldc ); sparse_status_t mkl_sparse_c_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex8 *C, int ldc ); sparse_status_t mkl_sparse_z_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex16 *C, int ldc ); sparse_status_t mkl_sparse_d_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const double alpha, const double beta, double *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_s_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const float alpha, const float beta, float *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_z_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex16 alpha, const MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_c_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex8 alpha, const MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_set_symgs_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_d_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x, double *y); sparse_status_t mkl_sparse_d_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x); sparse_status_t mkl_sparse_set_dotmv_hint( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expectedCalls ); sparse_status_t mkl_sparse_d_dotmv( sparse_operation_t transA, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y, double *d ); sparse_status_t mkl_sparse_s_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x, float *y); sparse_status_t mkl_sparse_s_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x); sparse_status_t mkl_sparse_s_dotmv( sparse_operation_t transA, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y, float *d ); sparse_status_t mkl_sparse_c_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x, MKL_Complex8 *y); sparse_status_t mkl_sparse_c_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x); sparse_status_t mkl_sparse_c_dotmv( sparse_operation_t transA, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y, MKL_Complex8 *d ); sparse_status_t mkl_sparse_z_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x, MKL_Complex16 *y); sparse_status_t mkl_sparse_z_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x); sparse_status_t mkl_sparse_z_dotmv( sparse_operation_t transA, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y, MKL_Complex16 *d ); sparse_status_t mkl_sparse_s_syrkd( sparse_operation_t operation, const sparse_matrix_t A, float alpha, float beta, float *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_d_syrkd( sparse_operation_t operation, const sparse_matrix_t A, double alpha, double beta, double *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_c_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_z_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, sparse_layout_t layout, int ldc ); #line 43 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_lapack.h" typedef int (*MKL_C_SELECT_FUNCTION_1) ( const MKL_Complex8* ); typedef int (*MKL_C_SELECT_FUNCTION_2) ( const MKL_Complex8*, const MKL_Complex8* ); typedef int (*MKL_D_SELECT_FUNCTION_2) ( const double*, const double* ); typedef int (*MKL_D_SELECT_FUNCTION_3) ( const double*, const double*, const double* ); typedef int (*MKL_S_SELECT_FUNCTION_2) ( const float*, const float* ); typedef int (*MKL_S_SELECT_FUNCTION_3) ( const float*, const float*, const float* ); typedef int (*MKL_Z_SELECT_FUNCTION_1) ( const MKL_Complex16* ); typedef int (*MKL_Z_SELECT_FUNCTION_2) ( const MKL_Complex16*, const MKL_Complex16* ); void CGELQ( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGELQ_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgelq( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgelq_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGELQT( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CGELQT_( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgelqt( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgelqt_( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CGELQT3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGELQT3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgelqt3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgelqt3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CGEQR( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGEQR_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgeqr( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgeqr_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgetsls( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLASWLQ( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void claswlq( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void claswlq_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CLATSQR( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CLATSQR_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void clatsqr( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void clatsqr_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CTPLQT( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CTPLQT_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctplqt( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctplqt_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CTPLQT2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void CTPLQT2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctplqt2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctplqt2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void CTPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CTPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void DGELQ( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DGELQ_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgelq( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgelq_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DGELQT( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void DGELQT_( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgelqt( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgelqt_( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void DGELQT3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGELQT3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgelqt3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgelqt3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void DGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void DGEQR( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DGEQR_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgeqr( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgeqr_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLASWLQ( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlaswlq( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlaswlq_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DLATSQR( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DLATSQR_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlatsqr( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlatsqr_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DTPLQT( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void DTPLQT_( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtplqt( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtplqt_( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void DTPLQT2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void DTPLQT2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtplqt2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtplqt2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void DTPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void DTPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void SGELQ( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void SGELQ_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgelq( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgelq_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void DGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgetsls( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void SGELQT( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void SGELQT_( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgelqt( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgelqt_( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void SGELQT3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGELQT3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgelqt3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgelqt3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void SGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void SGEQR( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void SGEQR_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgeqr( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgeqr_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void SGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgetsls( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLASWLQ( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void SLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slaswlq( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slaswlq_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void STPLQT( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void STPLQT_( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stplqt( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stplqt_( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void STPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void STPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void ZGELQ( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void ZGELQ_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgelq( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgelq_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void SGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLATSQR( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void SLATSQR_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slatsqr( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slatsqr_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void STPLQT2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void STPLQT2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stplqt2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stplqt2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void ZGELQT( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZGELQT_( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgelqt( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgelqt_( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZGELQT3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGELQT3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgelqt3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgelqt3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZGEQR( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQR_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgeqr( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgeqr_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void ZGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgetsls( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLASWLQ( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlaswlq( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlaswlq_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZLATSQR( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZLATSQR_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlatsqr( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlatsqr_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZTPLQT( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZTPLQT_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztplqt( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztplqt_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZTPLQT2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ZTPLQT2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztplqt2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztplqt2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ZTPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZTPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void CHESV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_AA( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_AA_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_aa( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_aa_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void CHETRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void chetrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void chetrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void CLAHEF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void CLAHEF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clahef_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clahef_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void DLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void DLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void dlasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void dlasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void DSYSV_AA( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_AA_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_aa( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_aa_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYTRF_AA( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_AA_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_aa( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_aa_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void DSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void dsytrs_aa( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void dsytrs_aa_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void SLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void SLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void slasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void slasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void SSYSV_AA( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_AA_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_aa( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_aa_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYTRF_AA( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_AA_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_aa( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_aa_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void SSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void ssytrs_aa( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void ssytrs_aa_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void ZHESV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_AA( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_AA_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_aa( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_aa_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void ZHETRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zhetrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zhetrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void ZLAHEF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void ZLAHEF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlahef_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlahef_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void CGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void DGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void SGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void ZGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void CHECON_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHECON_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHESV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHETF2_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CHETF2_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void chetf2_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void chetf2_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CHETRF_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_3X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CHETRI_3X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri_3x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri_3x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CHETRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHETRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CLAHEF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHEF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLARFY( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARFY_( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfy( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfy_( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void CLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void CLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CSYCON_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCON_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCONVF( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYCONVF_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csyconvf( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csyconvf_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYCONVF_ROOK( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void CSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void csyconvf_rook( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void csyconvf_rook_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void CSYSV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYTF2_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYTF2_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csytf2_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csytf2_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYTRF_AA( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_AA_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_aa( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_aa_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_3X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CSYTRI_3X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void csytri_3x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void csytri_3x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CSYTRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void CSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void csytrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void csytrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void DLARFY( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARFY_( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarfy( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarfy_( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void DLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void DSYCON_3( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCON_3_( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_3( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_3_( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCONVF( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYCONVF_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsyconvf( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsyconvf_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYCONVF_ROOK( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void DSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void dsyconvf_rook( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void dsyconvf_rook_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void DSYSV_RK( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_RK_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rk( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rk_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYTF2_RK( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYTF2_RK_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsytf2_rk( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsytf2_rk_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYTRF_RK( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_RK_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rk( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rk_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_3( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_3_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri_3( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri_3_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_3X( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void DSYTRI_3X_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void dsytri_3x( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void dsytri_3x_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void DSYTRS_3( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void DSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_3( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_3_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void SLARFY( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARFY_( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarfy( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarfy_( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void SLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void SSYCON_3( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCON_3_( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_3( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_3_( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCONVF( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYCONVF_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssyconvf( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssyconvf_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYCONVF_ROOK( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void SSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void ssyconvf_rook( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void ssyconvf_rook_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void SSYSV_RK( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_RK_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rk( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rk_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYTF2_RK( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYTF2_RK_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssytf2_rk( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssytf2_rk_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYTRF_RK( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_RK_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rk( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rk_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_3( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_3_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri_3( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri_3_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_3X( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void SSYTRI_3X_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void ssytri_3x( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void ssytri_3x_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void SSYTRS_3( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void SSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_3( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_3_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void ZHECON_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHECON_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHESV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHETF2_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZHETF2_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zhetf2_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zhetf2_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZHETRF_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_3X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZHETRI_3X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri_3x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri_3x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZHETRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHETRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZLAHEF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHEF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLARFY( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARFY_( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfy( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfy_( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void ZLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void ZLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZSYCON_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCON_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCONVF( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYCONVF_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsyconvf( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsyconvf_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYCONVF_ROOK( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void ZSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void zsyconvf_rook( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void zsyconvf_rook_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void ZSYSV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTF2_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYTF2_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsytf2_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsytf2_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYTRF_AA( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_AA_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_aa( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_aa_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_3X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZSYTRI_3X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zsytri_3x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zsytri_3x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZSYTRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zsytrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zsytrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void CHB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void CHB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void chb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void chb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void CHBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEEV_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEV_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEVD_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHETRD_2STAGE( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_2STAGE_( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_2stage( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_2stage_( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_hb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_hb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HE2HB( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HE2HB_( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_he2hb( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_he2hb_( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void DSB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void DSB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void dsb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void dsb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void DSBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DSBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DSBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYEV_2STAGE( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEV_2STAGE_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev_2stage( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev_2stage_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEVD_2STAGE( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd_2stage( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd_2stage_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYTRD_2STAGE( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void DSYTRD_2STAGE_( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void dsytrd_2stage( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void dsytrd_2stage_( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void DSYTRD_SB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void DSYTRD_SB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void dsytrd_sb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void dsytrd_sb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void DSYTRD_SY2SB( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); void DSYTRD_SY2SB_( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); void dsytrd_sy2sb( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); void dsytrd_sy2sb_( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); int IPARAM2STAGE( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); int IPARAM2STAGE_( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); int iparam2stage( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); int iparam2stage_( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); void SSB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void SSB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void ssb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void ssb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void SSBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SSBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SSBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYEV_2STAGE( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEV_2STAGE_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev_2stage( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev_2stage_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEVD_2STAGE( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd_2stage( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd_2stage_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYTRD_2STAGE( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void SSYTRD_2STAGE_( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void ssytrd_2stage( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void ssytrd_2stage_( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void SSYTRD_SB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void SSYTRD_SB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void ssytrd_sb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void ssytrd_sb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void SSYTRD_SY2SB( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void SSYTRD_SY2SB_( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void ssytrd_sy2sb( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void ssytrd_sy2sb_( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void ZHB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void ZHB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void zhb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void zhb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void ZHBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEEV_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEV_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEVD_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHETRD_2STAGE( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_2STAGE_( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_2stage( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_2stage_( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_hb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_hb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HE2HB( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HE2HB_( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_he2hb( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_he2hb_( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void MKL_CGETRFNP( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void MKL_CGETRFNP_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnp( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnp_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void MKL_DGETRFNP( const int* m, const int* n, double* a, const int* lda, int* info ); void MKL_DGETRFNP_( const int* m, const int* n, double* a, const int* lda, int* info ); void mkl_dgetrfnp( const int* m, const int* n, double* a, const int* lda, int* info ); void mkl_dgetrfnp_( const int* m, const int* n, double* a, const int* lda, int* info ); void MKL_SGETRFNP( const int* m, const int* n, float* a, const int* lda, int* info ); void MKL_SGETRFNP_( const int* m, const int* n, float* a, const int* lda, int* info ); void mkl_sgetrfnp( const int* m, const int* n, float* a, const int* lda, int* info ); void mkl_sgetrfnp_( const int* m, const int* n, float* a, const int* lda, int* info ); void MKL_ZGETRFNP( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void MKL_ZGETRFNP_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnp( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnp_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void MKL_CGETRINP( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void MKL_CGETRINP_( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void mkl_cgetrinp( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void mkl_cgetrinp_( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void MKL_DGETRINP( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void MKL_DGETRINP_( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void mkl_dgetrinp( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void mkl_dgetrinp_( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void MKL_SGETRINP( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void MKL_SGETRINP_( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void mkl_sgetrinp( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void mkl_sgetrinp_( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void MKL_ZGETRINP( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void MKL_ZGETRINP_( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void mkl_zgetrinp( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void mkl_zgetrinp_( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void CGEJSV( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void CGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void ZGEJSV( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void ZGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void DGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void DGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void SGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void SGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void CGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void CGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void cgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void cgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void ZGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void ZGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void zgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void zgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void CGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void CGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void cgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void cgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void ZGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void ZGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void zgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void zgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void DGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void DGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void dggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void dggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void SGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void SGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void sggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void sggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void CGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void ZGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void DGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void DGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void dggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void dggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void SGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void SGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void sggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void sggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void CGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void ZGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void CGSVJ0( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void CGSVJ0_( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj0( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj0_( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void ZGSVJ0( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void ZGSVJ0_( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj0( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj0_( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void CGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void CGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void ZGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void ZGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void CPOTRF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void DPOTRF2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRF2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void SPOTRF2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRF2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void ZPOTRF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void DBDSVDX( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void DBDSVDX_( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void dbdsvdx( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void dbdsvdx_( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void SBDSVDX( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void SBDSVDX_( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void sbdsvdx( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void sbdsvdx_( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void CGETRF2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETRF2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void DGETRF2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETRF2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void SGETRF2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETRF2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ZGETRF2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETRF2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void CGGEV3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGGEV3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void ZGGEV3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGGEV3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void DGGEV3( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGGEV3_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev3( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev3_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void SGGEV3( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGGEV3_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev3( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev3_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void CUNM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void ZUNM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void CGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void DGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void SGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void sgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void sgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ZGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void CGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void ZGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void DGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void DGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void SGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void SGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void DORM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dorm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dorm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void SORM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sorm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sorm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void CHECON_ROOK( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHECON_ROOK_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_rook( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_rook_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHESV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHETF2_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETF2_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETRF_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRI_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHETRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CLAHEF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHEF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CSYCON_ROOK( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCON_ROOK_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_rook( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_rook_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYTF2_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTF2_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTRF_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRI_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void DLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DSYCON_ROOK( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCON_ROOK_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_rook( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_rook_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rook( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rook_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYTF2_ROOK( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTF2_ROOK_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2_rook( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2_rook_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTRF_ROOK( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_ROOK_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rook( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rook_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_ROOK( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRI_ROOK_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri_rook( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri_rook_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_rook( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_rook_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void SLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SSYCON_ROOK( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCON_ROOK_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_rook( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_rook_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rook( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rook_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYTF2_ROOK( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTF2_ROOK_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2_rook( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2_rook_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTRF_ROOK( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_ROOK_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rook( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rook_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_ROOK( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRI_ROOK_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri_rook( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri_rook_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_rook( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_rook_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ZHECON_ROOK( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHECON_ROOK_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_rook( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_rook_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHESV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHETF2_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETF2_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETRF_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRI_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHETRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZLAHEF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHEF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZSYCON_ROOK( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCON_ROOK_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_rook( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_rook_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTF2_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTF2_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTRF_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRI_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void CUNBDB1( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB1_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb1( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb1_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB2( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB2_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb2( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb2_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB3( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB3_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb3( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb3_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB4( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB4_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb4( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb4_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB5( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB5_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb5( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb5_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB6( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB6_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb6( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb6_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void CUNCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cuncsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cuncsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void DORBDB1( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB1_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb1( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb1_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB2( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB2_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb2( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb2_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB3( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB3_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb3( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb3_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB4( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void DORBDB4_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void dorbdb4( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void dorbdb4_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void DORBDB5( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORBDB5_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb5( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb5_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORBDB6( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORBDB6_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb6( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb6_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void DORCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void dorcsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void dorcsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void SORBDB1( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB1_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb1( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb1_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB2( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB2_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb2( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb2_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB3( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB3_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb3( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb3_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB4( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void SORBDB4_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void sorbdb4( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void sorbdb4_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void SORBDB5( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORBDB5_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb5( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb5_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORBDB6( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORBDB6_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb6( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb6_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void SORCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void sorcsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void sorcsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void ZUNBDB1( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB1_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb1( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb1_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB2( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB2_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb2( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb2_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB3( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB3_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb3( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb3_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB4( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB4_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb4( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb4_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB5( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB5_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb5( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb5_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB6( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB6_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb6( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb6_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void ZUNCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zuncsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zuncsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void CGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void DGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void DGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void SGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void SGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void ZGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void CGEQRT( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CGEQRT_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgeqrt( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgeqrt_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void DGEQRT( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void DGEQRT_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgeqrt( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgeqrt_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void SGEQRT( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void SGEQRT_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgeqrt( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgeqrt_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void ZGEQRT( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZGEQRT_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgeqrt( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgeqrt_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void CGEQRT3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGEQRT3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void DGEQRT3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGEQRT3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void SGEQRT3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGEQRT3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void ZGEQRT3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGEQRT3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void CTPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CTPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void DTPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void DTPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void STPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void STPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void ZTPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZTPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void CTPQRT( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CTPQRT_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctpqrt( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctpqrt_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void DTPQRT( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void DTPQRT_( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtpqrt( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtpqrt_( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void STPQRT( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void STPQRT_( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stpqrt( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stpqrt_( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void ZTPQRT( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZTPQRT_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztpqrt( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztpqrt_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void CTPQRT2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void CTPQRT2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctpqrt2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctpqrt2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void DTPQRT2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void DTPQRT2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtpqrt2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtpqrt2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void STPQRT2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void STPQRT2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stpqrt2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stpqrt2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void ZTPQRT2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ZTPQRT2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztpqrt2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztpqrt2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void CBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void CBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void cbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void cbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void ZBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void ZBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void zbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void zbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void SBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void SBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void sbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void sbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void DBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void DBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void dbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void dbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void CUNBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void CUNBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void cunbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void cunbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void ZUNBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void ZUNBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void zunbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void zunbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void SORBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void SORBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void sorbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void sorbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void DORBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void DORBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void dorbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void dorbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void CUNCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void CUNCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void cuncsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void cuncsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void ZUNCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void ZUNCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void zuncsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void zuncsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void SORCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void SORCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void sorcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void sorcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void DORCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void DORCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void dorcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void dorcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void CLAPMR( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void CLAPMR_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmr( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmr_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void DLAPMR( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void DLAPMR_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmr( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmr_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void ZLAPMR( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void ZLAPMR_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmr( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmr_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void SLAPMR( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void SLAPMR_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmr( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmr_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void CSYCONV( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void CSYCONV_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void csyconv( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void csyconv_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void ZSYCONV( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void ZSYCONV_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void zsyconv( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void zsyconv_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void SSYCONV( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void SSYCONV_( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void ssyconv( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void ssyconv_( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void DSYCONV( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void DSYCONV_( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void dsyconv( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void dsyconv_( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void CSYSWAPR( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void CSYSWAPR_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void csyswapr( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void csyswapr_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void ZSYSWAPR( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void ZSYSWAPR_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zsyswapr( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zsyswapr_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void SSYSWAPR( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void SSYSWAPR_( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void ssyswapr( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void ssyswapr_( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void DSYSWAPR( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void DSYSWAPR_( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void dsyswapr( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void dsyswapr_( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void CSYTRI2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void ZSYTRI2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void SSYTRI2( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI2_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri2( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri2_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void DSYTRI2( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI2_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri2( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri2_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void CSYTRI2X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void CSYTRI2X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void csytri2x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void csytri2x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void ZSYTRI2X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void ZSYTRI2X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void zsytri2x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void zsytri2x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void SSYTRI2X( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void SSYTRI2X_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void ssytri2x( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void ssytri2x_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void DSYTRI2X( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void DSYTRI2X_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void dsytri2x( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void dsytri2x_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void SLARTGP( float* f, float* g, float* cs, float* sn, float* r ); void SLARTGP_( float* f, float* g, float* cs, float* sn, float* r ); void slartgp( float* f, float* g, float* cs, float* sn, float* r ); void slartgp_( float* f, float* g, float* cs, float* sn, float* r ); void DLARTGP( double* f, double* g, double* cs, double* sn, double* r ); void DLARTGP_( double* f, double* g, double* cs, double* sn, double* r ); void dlartgp( double* f, double* g, double* cs, double* sn, double* r ); void dlartgp_( double* f, double* g, double* cs, double* sn, double* r ); void SLARTGS( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void SLARTGS_( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void slartgs( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void slartgs_( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void DLARTGS( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void DLARTGS_( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void dlartgs( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void dlartgs_( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void CSYTRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CSYTRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void csytrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void csytrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ZSYTRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZSYTRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zsytrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zsytrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void SSYTRS2( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void SSYTRS2_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void ssytrs2( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void ssytrs2_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void DSYTRS2( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void DSYTRS2_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void dsytrs2( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void dsytrs2_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void CHETRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CHETRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void chetrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void chetrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ZHETRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZHETRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zhetrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zhetrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void CBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void CBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void cbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void cbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void CGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void CGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void cgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void cgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void CGBCON( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgbcon( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequb( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequb_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBEQU( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequ( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequ_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBTF2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTF2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtf2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtf2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTRF( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTRF_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtrf( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtrf_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGEBAL( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void CGEBAL_( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void cgebal( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void cgebal_( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void CGEBD2( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void CGEBD2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void cgebd2( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void cgebd2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void CGEBRD( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void CGEBRD_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void cgebrd( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void cgebrd_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void CGECON( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGECON_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgecon( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgecon_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGEEQUB( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEEQUB_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequb( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequb_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEEQU( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEEQU_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequ( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequ_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEES( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEES_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgees( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgees_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEESX( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEESX_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgeesx( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgeesx_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGS( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGS_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegs( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegs_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegv( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegv_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEHD2( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEHD2_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgehd2( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgehd2_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEHRD( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEHRD_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgehrd( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgehrd_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGELQ2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGELQ2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgelq2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgelq2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGELQF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGELQF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgelqf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgelqf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGELSD( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGELSD_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgelsd( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgelsd_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGELS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CGELS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgels( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgels_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CGELSS( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGELSS_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelss( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelss_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGELSX( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void CGELSX_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void cgelsx( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void cgelsx_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void CGELSY( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGELSY_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelsy( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelsy_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEQL2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQL2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeql2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeql2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQLF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQLF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqlf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqlf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQP3( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEQP3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeqp3( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeqp3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEQPF( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void CGEQPF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void cgeqpf( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void cgeqpf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void CGEQR2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQR2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQR2P( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQR2P_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2p( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2p_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQRF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQRF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQRFP( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQRFP_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrfp( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrfp_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGERFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGERFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgerfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgerfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGERQ2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGERQ2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgerq2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgerq2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGERQF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGERQF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgerqf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgerqf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGESC2( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void CGESC2_( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void cgesc2( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void cgesc2_( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void CGESDD( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGESDD_( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgesdd( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgesdd_( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGESV( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGESV_( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgesv( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgesv_( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGETC2( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void CGETC2_( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void cgetc2( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void cgetc2_( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void CGETF2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETF2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetf2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetf2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETRF( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETRF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void MKL_CGETRFNPI( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void MKL_CGETRFNPI_( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnpi( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnpi_( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void CGETRI( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CGETRI_( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void cgetri( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void cgetri_( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CGETRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGETRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgetrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgetrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGGBAL( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void CGGBAL_( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void cggbal( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void cggbal_( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void CGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void CGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void cggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void cggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void CGGEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGGEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void CGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void cggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void cggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void CGGGLM( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void CGGGLM_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void cggglm( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void cggglm_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void CGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void CGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void cgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void cgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void CGGLSE( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void CGGLSE_( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void cgglse( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void cgglse_( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void CGGQRF( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGQRF_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggqrf( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggqrf_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGRQF( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGRQF_( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggrqf( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggrqf_( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void cggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void cggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGTCON( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CGTCON_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cgtcon( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cgtcon_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CGTRFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTRFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtrfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtrfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTSV( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CGTSV_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cgtsv( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cgtsv_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTTRF( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void CGTTRF_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void cgttrf( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void cgttrf_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void CGTTRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGTTRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgttrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgttrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGTTS2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void CGTTS2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void cgtts2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void cgtts2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void CHBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEV( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbev( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbev_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void CHBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void chbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void chbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void CHBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBTRD( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CHBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void chbtrd( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void chbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CHECON( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHECON_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHEEQUB( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CHEEQUB_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void cheequb( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void cheequb_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CHEEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEV( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEVR( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVR_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEGS2( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGS2_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegs2( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegs2_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGST( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGST_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegst( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegst_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chegvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chegvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chegvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chegvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHERFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHERFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cherfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cherfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHERFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHERFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cherfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cherfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHESV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHESVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chesvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chesvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHESVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHESVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void chesvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void chesvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHETD2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void CHETD2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void chetd2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void chetd2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void CHETF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETRD( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRI_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHETRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void CHFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void chfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void chfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void CHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHLA_TRANSTYPE( char* ret_val, int ret_val_len, const int* trans ); void CHLA_TRANSTYPE_( char* ret_val, int ret_val_len, const int* trans ); void chla_transtype( char* ret_val, int ret_val_len, const int* trans ); void chla_transtype_( char* ret_val, int ret_val_len, const int* trans ); void CHPCON( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHPCON_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void chpcon( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void chpcon_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHPEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpevd( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPEV( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpev( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpev_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPGST( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void CHPGST_( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void chpgst( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void chpgst_( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void CHPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpgvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpgv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpgv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chpsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chpsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chpsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chpsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPTRD( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void CHPTRD_( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void chptrd( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void chptrd_( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void CHPTRF( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CHPTRF_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void chptrf( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void chptrf_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CHPTRI( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CHPTRI_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void chptri( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void chptri_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CHPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHSEIN( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void CHSEIN_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void chsein( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void chsein_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void CHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void chseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void chseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLABRD( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void CLABRD_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void clabrd( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void clabrd_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void CLACGV( const int* n, MKL_Complex8* x, const int* incx ); void CLACGV_( const int* n, MKL_Complex8* x, const int* incx ); void clacgv( const int* n, MKL_Complex8* x, const int* incx ); void clacgv_( const int* n, MKL_Complex8* x, const int* incx ); void CLACN2( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void CLACN2_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void clacn2( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void clacn2_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void CLACON( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void CLACON_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void clacon( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void clacon_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void CLACP2( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACP2_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacp2( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacp2_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACPY( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACPY_( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacpy( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacpy_( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACRM( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLACRM_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clacrm( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clacrm_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLACRT( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void CLACRT_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void clacrt( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void clacrt_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void CLADIV( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void CLADIV_( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void cladiv( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void cladiv_( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void CLAED0( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void CLAED0_( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void claed0( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void claed0_( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void CLAED7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CLAED7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void claed7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void claed7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CLAED8( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void CLAED8_( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void claed8( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void claed8_( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void CLAEIN( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void CLAEIN_( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void claein( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void claein_( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void CLAESY( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void CLAESY_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void claesy( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void claesy_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void CLAEV2( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void CLAEV2_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void claev2( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void claev2_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void CLAG2Z( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void CLAG2Z_( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void clag2z( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void clag2z_( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void CLAGS2( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void CLAGS2_( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void clags2( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void clags2_( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void CLAGTM( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void CLAGTM_( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void clagtm( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void clagtm_( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void CLAHEF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHEF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void CLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void clahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void clahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void CLAHR2( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAHR2_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahr2( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahr2_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAHRD( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAHRD_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahrd( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahrd_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAIC1( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void CLAIC1_( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void claic1( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void claic1_( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void CLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void CLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void clals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void clals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void CLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void CLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void clalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void clalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void CLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void clalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void clalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); float CLANGB( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float clangb( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float clangb_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANGE( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANGE_( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clange( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clange_( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANGT( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float CLANGT_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float clangt( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float clangt_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float CLANHB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANHB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clanhb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clanhb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANHE( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHE_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhe( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhe_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHF( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float CLANHF_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float clanhf( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float clanhf_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float CLANHP( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANHP_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clanhp( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clanhp_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANHS( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHS_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhs( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhs_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHT( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float CLANHT_( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float clanht( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float clanht_( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float CLANSB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clansb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clansb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANSP( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANSP_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clansp( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clansp_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANSY( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANSY_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clansy( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clansy_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float CLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float clantp( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float clantp_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float CLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); void CLAPLL( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void CLAPLL_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void clapll( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void clapll_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void CLAPMT( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void CLAPMT_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmt( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmt_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void CLAQGB( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQGB_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqgb( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqgb_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQGE( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQGE_( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqge( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqge_( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQHB( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void CLAQHB_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void claqhb( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void claqhb_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void CLAQHE( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAQHE_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqhe( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqhe_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAQHP( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQHP_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqhp( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqhp_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQP2( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void CLAQP2_( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void claqp2( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void claqp2_( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void CLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void CLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void claqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void claqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void CLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR1( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void CLAQR1_( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void claqr1( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void claqr1_( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void CLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void CLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void claqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void claqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void CLAQSB( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSB_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void claqsb( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void claqsb_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSP( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSP_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqsp( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqsp_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSY( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSY_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqsy( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqsy_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAR1V( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void CLAR1V_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void clar1v( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void clar1v_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void CLAR2V( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void CLAR2V_( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void clar2v( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void clar2v_( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void CLARCM( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLARCM_( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clarcm( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clarcm_( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARF( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARF_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarf( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarf_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARFG( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFG_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfg( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfg_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFGP( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFGP_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfgp( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfgp_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFP( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFP_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfp( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfp_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFT( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLARFT_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarft( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarft_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLARFX( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARFX_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfx( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfx_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARGV( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void CLARGV_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void clargv( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void clargv_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void CLARNV( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void CLARNV_( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void clarnv( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void clarnv_( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void CLARRV( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void CLARRV_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void clarrv( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void clarrv_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void CLARSCL2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLARSCL2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clarscl2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clarscl2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLARTG( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void CLARTG_( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void clartg( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void clartg_( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void CLARTV( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void CLARTV_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void clartv( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void clartv_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void CLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARZ( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARZ_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarz( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarz_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARZT( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLARZT_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarzt( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarzt_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLASCL( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLASCL_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clascl( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clascl_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLASCL2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLASCL2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clascl2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clascl2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLASET( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void CLASET_( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void claset( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void claset_( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void CLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void CLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void clasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void clasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void CLASSQ( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void CLASSQ_( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void classq( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void classq_( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void CLASWP( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void CLASWP_( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void claswp( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void claswp_( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void CLASYF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATDF( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void CLATDF_( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void clatdf( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void clatdf_( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void CLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATRD( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void CLATRD_( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void clatrd( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void clatrd_( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void CLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATRZ( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void CLATRZ_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void clatrz( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void clatrz_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void CLATZM( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void CLATZM_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void clatzm( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void clatzm_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void CLAUU2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLAUU2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauu2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauu2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLAUUM( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLAUUM_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauum( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauum_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPBCON( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPBCON_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpbcon( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpbcon_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPBEQU( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void CPBEQU_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void cpbequ( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void cpbequ_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void CPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBSTF( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBSTF_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbstf( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbstf_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBTF2( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTF2_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtf2( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtf2_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTRF( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTRF_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtrf( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtrf_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPFTRF( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRF_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftrf( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftrf_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRI( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRI_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftri( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftri_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void CPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void cpftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void cpftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void CPOCON( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPOCON_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpocon( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpocon_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPOEQUB( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPOEQUB_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequb( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequb_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPOEQU( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPOEQU_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequ( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequ_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPORFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPORFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cporfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cporfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPOSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPOSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cposv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cposv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPOTF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRI( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRI_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotri( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotri_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPOTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cpotrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cpotrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPPCON( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPPCON_( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cppcon( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cppcon_( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPPEQU( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void CPPEQU_( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void cppequ( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void cppequ_( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void CPPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cppsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cppsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPTRF( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRF_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptrf( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptrf_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRI( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRI_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptri( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptri_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cpptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cpptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPSTF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPSTF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPSTRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPSTRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPTCON( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void CPTCON_( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void cptcon( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void cptcon_( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void CPTEQR( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CPTEQR_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void cpteqr( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void cpteqr_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CPTRFS( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTRFS_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptrfs( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptrfs_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTSV( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTSV_( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cptsv( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cptsv_( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTSVX( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTSVX_( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptsvx( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptsvx_( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTTRF( const int* n, float* d, MKL_Complex8* e, int* info ); void CPTTRF_( const int* n, float* d, MKL_Complex8* e, int* info ); void cpttrf( const int* n, float* d, MKL_Complex8* e, int* info ); void cpttrf_( const int* n, float* d, MKL_Complex8* e, int* info ); void CPTTRS( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTTRS_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cpttrs( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cpttrs_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTTS2( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void CPTTS2_( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void cptts2( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void cptts2_( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void CROT( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void CROT_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void crot( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void crot_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void CSPCON( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSPCON_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cspcon( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cspcon_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSPMV( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSPMV_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void cspmv( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void cspmv_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSPR( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void CSPR_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void cspr( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void cspr_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void CSPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cspsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cspsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPTRF( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CSPTRF_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void csptrf( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void csptrf_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CSPTRI( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CSPTRI_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void csptri( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void csptri_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CSPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSRSCL( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void CSRSCL_( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void csrscl( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void csrscl_( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void CSTEDC( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CSTEDC_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cstedc( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cstedc_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CSTEGR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEGR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstegr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstegr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEIN( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void CSTEIN_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void cstein( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void cstein_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void CSTEMR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEMR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstemr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstemr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEQR( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CSTEQR_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void csteqr( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void csteqr_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CSYCON( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCON_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYEQUB( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CSYEQUB_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void csyequb( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void csyequb_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CSYMV( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSYMV_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void csymv( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void csymv_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSYR( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void CSYR_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void csyr( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void csyr_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void CSYRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSYRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csyrfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csyrfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void csysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void csysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYTF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRI_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CTBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CTBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void ctbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void ctbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CTFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void CTFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void ctfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void ctfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void CTFTRI( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void CTFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void ctftri( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void ctftri_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void CTFTTP( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void CTFTTP_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void ctfttp( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void ctfttp_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void CTFTTR( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void CTFTTR_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void ctfttr( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void ctfttr_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void CTGEVC( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTGEVC_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctgevc( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctgevc_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTGEX2( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void CTGEX2_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void ctgex2( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void ctgex2_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void CTGEXC( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void CTGEXC_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ctgexc( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ctgexc_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void CTGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CTGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ctgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ctgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CTGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void CTGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void ctgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void ctgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void CTGSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTGSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTGSY2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void CTGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void ctgsy2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void ctgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void CTGSYL( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsyl( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTPCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctpcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTPTRI( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void CTPTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void ctptri( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void ctptri_( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void CTPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CTPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void ctptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void ctptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CTPTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void CTPTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void ctpttf( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void ctpttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void CTPTTR( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void CTPTTR_( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void ctpttr( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void ctpttr_( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void CTRCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctrcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctrcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTREVC( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTREVC_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctrevc( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctrevc_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTREXC( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void CTREXC_( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ctrexc( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ctrexc_( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void CTRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctrrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctrrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTRSEN( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void CTRSEN_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void ctrsen( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void ctrsen_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void CTRSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void CTRSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void ctrsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void ctrsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void CTRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void CTRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void ctrsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void ctrsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void CTRTI2( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTI2_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrti2( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrti2_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTRI( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrtri( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrtri_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CTRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void ctrtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void ctrtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CTRTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void CTRTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void ctrttf( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void ctrttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void CTRTTP( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void CTRTTP_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void ctrttp( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void ctrttp_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void CTZRQF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void CTZRQF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void ctzrqf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void ctzrqf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void CTZRZF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CTZRZF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void ctzrzf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void ctzrzf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNG2L( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNG2L_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2l( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2l_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNG2R( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNG2R_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2r( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2r_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGBR( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGBR_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungbr( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungbr_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGHR( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGHR_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunghr( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunghr_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGL2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGL2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungl2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungl2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGLQ( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGLQ_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunglq( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunglq_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQL( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQL_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungql( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungql_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQR( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQR_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungqr( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungqr_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGR2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGR2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungr2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungr2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGRQ( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGRQ_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungrq( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungrq_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGTR( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGTR_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungtr( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungtr_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmql( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUPGTR( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CUPGTR_( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void cupgtr( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void cupgtr_( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CUPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cupmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cupmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void DBDSDC( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void DBDSDC_( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void dbdsdc( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void dbdsdc_( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void DBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DDISNA( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void DDISNA_( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void ddisna( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void ddisna_( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void DGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void DGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void dgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void dgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void DGBCON( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgbcon( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequb( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequb_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBEQU( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequ( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequ_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void DGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void dgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void dgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void DGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBTF2( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTF2_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtf2( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtf2_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTRF( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTRF_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtrf( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtrf_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void DGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void dgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void dgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void DGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void DGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void dgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void dgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void DGEBAL( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void DGEBAL_( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void dgebal( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void dgebal_( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void DGEBD2( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void DGEBD2_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void dgebd2( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void dgebd2_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void DGEBRD( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void DGEBRD_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void dgebrd( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void dgebrd_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void DGECON( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGECON_( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgecon( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgecon_( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGEEQUB( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEEQUB_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequb( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequb_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEEQU( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEEQU_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequ( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequ_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEES( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void DGEES_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void dgees( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void dgees_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void DGEESX( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGEESX_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dgeesx( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dgeesx_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGEEV( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEEV_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgeev( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgeev_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void DGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void dgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void dgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void DGEGS( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void DGEGS_( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void dgegs( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void dgegs_( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void DGEGV( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEGV_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgegv( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgegv_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEHD2( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void DGEHD2_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void dgehd2( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void dgehd2_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void DGEHRD( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEHRD_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgehrd( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgehrd_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEJSV( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void DGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void dgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void dgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void DGELQ2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGELQ2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgelq2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgelq2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGELQF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGELQF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgelqf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgelqf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGELSD( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void DGELSD_( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void dgelsd( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void dgelsd_( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void DGELS( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DGELS_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgels( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgels_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DGELSS( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGELSS_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelss( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelss_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGELSX( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void DGELSX_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void dgelsx( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void dgelsx_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void DGELSY( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGELSY_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelsy( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelsy_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGEQL2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQL2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeql2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeql2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQLF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQLF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqlf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqlf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQP3( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void DGEQP3_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void dgeqp3( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void dgeqp3_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void DGEQPF( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void DGEQPF_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void dgeqpf( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void dgeqpf_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void DGEQR2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQR2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQR2P( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQR2P_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2p( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2p_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQRF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQRF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQRFP( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQRFP_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrfp( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrfp_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGERFS( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGERFS_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgerfs( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgerfs_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGERQ2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGERQ2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgerq2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgerq2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGERQF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGERQF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgerqf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgerqf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGESC2( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void DGESC2_( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void dgesc2( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void dgesc2_( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void DGESDD( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void DGESDD_( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesdd( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesdd_( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void DGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void DGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void dgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void dgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void DGESV( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void DGESV_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void dgesv( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void dgesv_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void DGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void DGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void dgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void dgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void DGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGETC2( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void DGETC2_( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void dgetc2( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void dgetc2_( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void DGETF2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETF2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetf2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetf2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETRF( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETRF_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void MKL_DGETRFNPI( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void MKL_DGETRFNPI_( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void mkl_dgetrfnpi( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void mkl_dgetrfnpi_( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void DGETRI( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void DGETRI_( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dgetri( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dgetri_( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void DGETRS( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DGETRS_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dgetrs( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dgetrs_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void DGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void dggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void dggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void DGGBAL( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void DGGBAL_( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void dggbal( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void dggbal_( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void DGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void DGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void DGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGGEV( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGGEV_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void DGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void dggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void dggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void DGGGLM( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void DGGGLM_( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void dggglm( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void dggglm_( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void DGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void DGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void dgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void dgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void DGGLSE( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void DGGLSE_( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void dgglse( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void dgglse_( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void DGGQRF( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGQRF_( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggqrf( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggqrf_( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGRQF( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGRQF_( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggrqf( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggrqf_( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void DGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void dggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void dggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void DGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void DGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void dggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void dggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void DGSVJ0( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGSVJ0_( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj0( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj0_( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj1( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGTCON( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGTCON_( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgtcon( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgtcon_( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGTRFS( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTRFS_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtrfs( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtrfs_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTSV( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void DGTSV_( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void dgtsv( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void dgtsv_( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void DGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTTRF( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void DGTTRF_( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void dgttrf( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void dgttrf_( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void DGTTRS( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void DGTTRS_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void dgttrs( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void dgttrs_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void DGTTS2( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void DGTTS2_( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void dgtts2( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void dgtts2_( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void DHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DHSEIN( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void DHSEIN_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void dhsein( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void dhsein_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void DHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); int DISNAN( const double* din ); int DISNAN_( const double* din ); int disnan( const double* din ); int disnan_( const double* din ); void DLABAD( double* smallx, double* large ); void DLABAD_( double* smallx, double* large ); void dlabad( double* smallx, double* large ); void dlabad_( double* smallx, double* large ); void DLABRD( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void DLABRD_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void dlabrd( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void dlabrd_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void DLACN2( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void DLACN2_( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void dlacn2( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void dlacn2_( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void DLACON( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void DLACON_( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void dlacon( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void dlacon_( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void DLACPY( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void DLACPY_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void dlacpy( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void dlacpy_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void DLADIV( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void DLADIV_( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void dladiv( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void dladiv_( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void DLAE2( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void DLAE2_( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void dlae2( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void dlae2_( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void DLAEBZ( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void DLAEBZ_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void dlaebz( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void dlaebz_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void DLAED0( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void DLAED0_( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void dlaed0( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void dlaed0_( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void DLAED1( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void DLAED1_( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void dlaed1( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void dlaed1_( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void DLAED2( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void DLAED2_( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void dlaed2( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void dlaed2_( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void DLAED3( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void DLAED3_( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void dlaed3( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void dlaed3_( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void DLAED4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void DLAED4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void dlaed4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void dlaed4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void DLAED5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void DLAED5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void dlaed5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void dlaed5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void DLAED6( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void DLAED6_( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void dlaed6( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void dlaed6_( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void DLAED7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void DLAED7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void dlaed7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void dlaed7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void DLAED8( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void DLAED8_( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void dlaed8( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void dlaed8_( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void DLAED9( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void DLAED9_( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void dlaed9( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void dlaed9_( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void DLAEDA( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void DLAEDA_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void dlaeda( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void dlaeda_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void DLAEIN( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void DLAEIN_( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void dlaein( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void dlaein_( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void DLAEV2( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void DLAEV2_( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void dlaev2( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void dlaev2_( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void DLAEXC( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void DLAEXC_( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void dlaexc( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void dlaexc_( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void DLAG2( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void DLAG2_( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void dlag2( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void dlag2_( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void DLAG2S( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLAG2S_( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlag2s( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlag2s_( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLAGS2( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void DLAGS2_( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void dlags2( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void dlags2_( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void DLAGTF( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void DLAGTF_( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void dlagtf( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void dlagtf_( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void DLAGTM( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void DLAGTM_( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void dlagtm( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void dlagtm_( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void DLAGTS( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void DLAGTS_( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void dlagts( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void dlagts_( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void DLAGV2( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void DLAGV2_( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void dlagv2( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void dlagv2_( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void DLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void DLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void dlahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void dlahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void DLAHR2( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAHR2_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahr2( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahr2_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAHRD( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAHRD_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahrd( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahrd_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAIC1( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); void DLAIC1_( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); void dlaic1( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); void dlaic1_( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); int DLAISNAN( const double* din1, const double* din2 ); int DLAISNAN_( const double* din1, const double* din2 ); int dlaisnan( const double* din1, const double* din2 ); int dlaisnan_( const double* din1, const double* din2 ); void DLALN2( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void DLALN2_( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void dlaln2( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void dlaln2_( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void DLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void DLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void dlals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void dlals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void DLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void DLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void dlalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void dlalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void DLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); void DLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); void dlalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); void dlalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); double DLAMCH( const char* cmach ); double DLAMCH_( const char* cmach ); double dlamch( const char* cmach ); double dlamch_( const char* cmach ); void DLAMC1( int* beta, int* t, int* rnd, int* ieee1 ); void DLAMC1_( int* beta, int* t, int* rnd, int* ieee1 ); void dlamc1( int* beta, int* t, int* rnd, int* ieee1 ); void dlamc1_( int* beta, int* t, int* rnd, int* ieee1 ); void DLAMC2( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); void DLAMC2_( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); void dlamc2( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); void dlamc2_( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); double DLAMC3( const double* a, const double* b ); double DLAMC3_( const double* a, const double* b ); double dlamc3( const double* a, const double* b ); double dlamc3_( const double* a, const double* b ); void DLAMC4( int* emin, const double* start, const int* base ); void DLAMC4_( int* emin, const double* start, const int* base ); void dlamc4( int* emin, const double* start, const int* base ); void dlamc4_( int* emin, const double* start, const int* base ); void DLAMC5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void DLAMC5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void dlamc5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void dlamc5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void DLAMRG( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); void DLAMRG_( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); void dlamrg( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); void dlamrg_( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); int DLANEG( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); int DLANEG_( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); int dlaneg( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); int dlaneg_( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); double DLANGB( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double DLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double dlangb( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double dlangb_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double DLANGE( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double DLANGE_( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlange( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlange_( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double DLANGT( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double DLANGT_( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double dlangt( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double dlangt_( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double DLANHS( const char* norm, const int* n, const double* a, const int* lda, double* work ); double DLANHS_( const char* norm, const int* n, const double* a, const int* lda, double* work ); double dlanhs( const char* norm, const int* n, const double* a, const int* lda, double* work ); double dlanhs_( const char* norm, const int* n, const double* a, const int* lda, double* work ); double DLANSB( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlansb( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlansb_( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANSF( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double DLANSF_( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double dlansf( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double dlansf_( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double DLANSP( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double DLANSP_( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double dlansp( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double dlansp_( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double DLANST( const char* norm, const int* n, const double* d, const double* e ); double DLANST_( const char* norm, const int* n, const double* d, const double* e ); double dlanst( const char* norm, const int* n, const double* d, const double* e ); double dlanst_( const char* norm, const int* n, const double* d, const double* e ); double DLANSY( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double DLANSY_( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double dlansy( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double dlansy_( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double DLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double DLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double dlantp( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double dlantp_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double DLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); double DLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); void DLANV2( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void DLANV2_( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void dlanv2( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void dlanv2_( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void DLAPLL( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void DLAPLL_( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void dlapll( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void dlapll_( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void DLAPMT( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void DLAPMT_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmt( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmt_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); double DLAPY2( const double* x, const double* y ); double DLAPY2_( const double* x, const double* y ); double dlapy2( const double* x, const double* y ); double dlapy2_( const double* x, const double* y ); double DLAPY3( const double* x, const double* y, const double* z ); double DLAPY3_( const double* x, const double* y, const double* z ); double dlapy3( const double* x, const double* y, const double* z ); double dlapy3_( const double* x, const double* y, const double* z ); void DLAQGB( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQGB_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqgb( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqgb_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQGE( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQGE_( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqge( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqge_( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQP2( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void DLAQP2_( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void dlaqp2( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void dlaqp2_( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void DLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void DLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void dlaqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void dlaqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void DLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR1( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void DLAQR1_( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void dlaqr1( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void dlaqr1_( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void DLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void DLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void dlaqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void dlaqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void DLAQSB( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSB_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsb( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsb_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSP( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSP_( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsp( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsp_( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSY( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSY_( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsy( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsy_( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void DLAQTR( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void DLAQTR_( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void dlaqtr( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void dlaqtr_( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void DLAR1V( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void DLAR1V_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void dlar1v( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void dlar1v_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void DLAR2V( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void DLAR2V_( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void dlar2v( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void dlar2v_( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void DLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARF( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARF_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarf( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarf_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARFG( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFG_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfg( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfg_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFGP( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFGP_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfgp( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfgp_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFP( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFP_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfp( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfp_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFT( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLARFT_( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarft( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarft_( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLARFX( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void DLARFX_( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void dlarfx( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void dlarfx_( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void DLARGV( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void DLARGV_( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void dlargv( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void dlargv_( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void DLARNV( const int* idist, int* iseed, const int* n, double* x ); void DLARNV_( const int* idist, int* iseed, const int* n, double* x ); void dlarnv( const int* idist, int* iseed, const int* n, double* x ); void dlarnv_( const int* idist, int* iseed, const int* n, double* x ); void DLARRA( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void DLARRA_( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void dlarra( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void dlarra_( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void DLARRB( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void DLARRB_( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void dlarrb( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void dlarrb_( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void DLARRC( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void DLARRC_( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void dlarrc( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void dlarrc_( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void DLARRD( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void DLARRD_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void dlarrd( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void dlarrd_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void DLARRE( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void DLARRE_( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void dlarre( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void dlarre_( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void DLARRF( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void DLARRF_( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void dlarrf( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void dlarrf_( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void DLARRJ( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void DLARRJ_( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void dlarrj( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void dlarrj_( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void DLARRK( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void DLARRK_( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void dlarrk( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void dlarrk_( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void DLARRR( const int* n, const double* d, double* e, int* info ); void DLARRR_( const int* n, const double* d, double* e, int* info ); void dlarrr( const int* n, const double* d, double* e, int* info ); void dlarrr_( const int* n, const double* d, double* e, int* info ); void DLARRV( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void DLARRV_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void dlarrv( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void dlarrv_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void DLARSCL2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLARSCL2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlarscl2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlarscl2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLARTG( const double* f, const double* g, double* cs, double* sn, double* r ); void DLARTG_( const double* f, const double* g, double* cs, double* sn, double* r ); void dlartg( const double* f, const double* g, double* cs, double* sn, double* r ); void dlartg_( const double* f, const double* g, double* cs, double* sn, double* r ); void DLARTV( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void DLARTV_( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void dlartv( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void dlartv_( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void DLARUV( int* iseed, const int* n, double* x ); void DLARUV_( int* iseed, const int* n, double* x ); void dlaruv( int* iseed, const int* n, double* x ); void dlaruv_( int* iseed, const int* n, double* x ); void DLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARZ( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARZ_( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarz( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarz_( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARZT( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLARZT_( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarzt( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarzt_( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLAS2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void DLAS2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void dlas2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void dlas2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void DLASCL( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void DLASCL_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void dlascl( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void dlascl_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void DLASCL2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLASCL2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlascl2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlascl2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLASD0( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void DLASD0_( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void dlasd0( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void dlasd0_( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void DLASD1( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void DLASD1_( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void dlasd1( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void dlasd1_( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void DLASD2( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void DLASD2_( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void dlasd2( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void dlasd2_( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void DLASD3( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void DLASD3_( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void dlasd3( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void dlasd3_( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void DLASD4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void DLASD4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void dlasd4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void dlasd4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void DLASD5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void DLASD5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void dlasd5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void dlasd5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void DLASD6( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void DLASD6_( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void dlasd6( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void dlasd6_( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void DLASD7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void DLASD7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void dlasd7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void dlasd7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void DLASD8( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void DLASD8_( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void dlasd8( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void dlasd8_( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void DLASDA( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void DLASDA_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void dlasda( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void dlasda_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void DLASDQ( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DLASDQ_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dlasdq( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dlasdq_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DLASDT( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void DLASDT_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void dlasdt( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void dlasdt_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void DLASET( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void DLASET_( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void dlaset( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void dlaset_( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void DLASQ1( const int* n, double* d, double* e, double* work, int* info ); void DLASQ1_( const int* n, double* d, double* e, double* work, int* info ); void dlasq1( const int* n, double* d, double* e, double* work, int* info ); void dlasq1_( const int* n, double* d, double* e, double* work, int* info ); void DLASQ2( const int* n, double* z, int* info ); void DLASQ2_( const int* n, double* z, int* info ); void dlasq2( const int* n, double* z, int* info ); void dlasq2_( const int* n, double* z, int* info ); void DLASQ3( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void DLASQ3_( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void dlasq3( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void dlasq3_( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void DLASQ4( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void DLASQ4_( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void dlasq4( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void dlasq4_( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void DLASQ5( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void DLASQ5_( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void dlasq5( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void dlasq5_( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void DLASQ6( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void DLASQ6_( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void dlasq6( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void dlasq6_( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void DLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void DLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void dlasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void dlasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void DLASRT( const char* id, const int* n, double* d, int* info ); void DLASRT_( const char* id, const int* n, double* d, int* info ); void dlasrt( const char* id, const int* n, double* d, int* info ); void dlasrt_( const char* id, const int* n, double* d, int* info ); void DLASSQ( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void DLASSQ_( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void dlassq( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void dlassq_( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void DLASV2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void DLASV2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void dlasv2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void dlasv2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void DLASWP( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void DLASWP_( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void dlaswp( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void dlaswp_( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void DLASY2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void DLASY2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void dlasy2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void dlasy2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void DLASYF( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DLASYF_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DLAT2S( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLAT2S_( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlat2s( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlat2s_( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void DLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void dlatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void dlatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void DLATDF( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void DLATDF_( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void dlatdf( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void dlatdf_( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void DLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void DLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void dlatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void dlatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void DLATRD( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void DLATRD_( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void dlatrd( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void dlatrd_( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void DLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void DLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void dlatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void dlatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void DLATRZ( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void DLATRZ_( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void dlatrz( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void dlatrz_( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void DLATZM( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void DLATZM_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void dlatzm( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void dlatzm_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void DLAUU2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DLAUU2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauu2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauu2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DLAUUM( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DLAUUM_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauum( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauum_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DOPGTR( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void DOPGTR_( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void dopgtr( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void dopgtr_( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void DOPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void DOPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void dopmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void dopmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORG2L( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORG2L_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2l( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2l_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORG2R( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORG2R_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2r( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2r_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGBR( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGBR_( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgbr( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgbr_( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGHR( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGHR_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorghr( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorghr_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGL2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGL2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgl2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgl2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGLQ( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGLQ_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorglq( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorglq_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQL( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQL_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgql( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgql_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQR( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQR_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgqr( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgqr_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGR2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGR2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgr2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgr2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGRQ( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGRQ_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgrq( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgrq_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGTR( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGTR_( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgtr( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgtr_( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormql( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DPBCON( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPBCON_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpbcon( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpbcon_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPBEQU( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void DPBEQU_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void dpbequ( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void dpbequ_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void DPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBSTF( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBSTF_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbstf( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbstf_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBTF2( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTF2_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtf2( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtf2_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTRF( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTRF_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtrf( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtrf_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPFTRF( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRF_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftrf( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftrf_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRI( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRI_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftri( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftri_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void DPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void dpftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void dpftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void DPOCON( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPOCON_( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpocon( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpocon_( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPOEQUB( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPOEQUB_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequb( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequb_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPOEQU( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPOEQU_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequ( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequ_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPORFS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPORFS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dporfs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dporfs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPOSV( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void DPOSV_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void dposv( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void dposv_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void DPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPOTF2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTF2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotf2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotf2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRF( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRF_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRI( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRI_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotri( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotri_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DPOTRS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dpotrs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dpotrs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DPPCON( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPPCON_( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dppcon( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dppcon_( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPPEQU( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void DPPEQU_( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void dppequ( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void dppequ_( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void DPPRFS( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPRFS_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpprfs( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpprfs_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPSV( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void DPPSV_( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void dppsv( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void dppsv_( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void DPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPTRF( const char* uplo, const int* n, double* ap, int* info ); void DPPTRF_( const char* uplo, const int* n, double* ap, int* info ); void dpptrf( const char* uplo, const int* n, double* ap, int* info ); void dpptrf_( const char* uplo, const int* n, double* ap, int* info ); void DPPTRI( const char* uplo, const int* n, double* ap, int* info ); void DPPTRI_( const char* uplo, const int* n, double* ap, int* info ); void dpptri( const char* uplo, const int* n, double* ap, int* info ); void dpptri_( const char* uplo, const int* n, double* ap, int* info ); void DPPTRS( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DPPTRS_( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dpptrs( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dpptrs_( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DPSTF2( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPSTF2_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstf2( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstf2_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPSTRF( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPSTRF_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstrf( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstrf_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPTCON( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void DPTCON_( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void dptcon( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void dptcon_( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void DPTEQR( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DPTEQR_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dpteqr( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dpteqr_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DPTRFS( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void DPTRFS_( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void dptrfs( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void dptrfs_( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void DPTSV( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void DPTSV_( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void dptsv( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void dptsv_( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void DPTSVX( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void DPTSVX_( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void dptsvx( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void dptsvx_( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void DPTTRF( const int* n, double* d, double* e, int* info ); void DPTTRF_( const int* n, double* d, double* e, int* info ); void dpttrf( const int* n, double* d, double* e, int* info ); void dpttrf_( const int* n, double* d, double* e, int* info ); void DPTTRS( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void DPTTRS_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void dpttrs( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void dpttrs_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void DPTTS2( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void DPTTS2_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void dptts2( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void dptts2_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void DRSCL( const int* n, const double* sa, double* sx, const int* incx ); void DRSCL_( const int* n, const double* sa, double* sx, const int* incx ); void drscl( const int* n, const double* sa, double* sx, const int* incx ); void drscl_( const int* n, const double* sa, double* sx, const int* incx ); void DSBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEV( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void DSBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void dsbev( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void dsbev_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void DSBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void DSBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void dsbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void dsbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void DSBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void DSBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void dsbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void dsbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void DSBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBTRD( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); void DSBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); void dsbtrd( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); void dsbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); double DSECND( void ); double DSECND_( void ); double dsecnd( void ); double dsecnd_( void ); void DSFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void DSFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void dsfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void dsfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void DSGESV( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSGESV_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsgesv( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsgesv_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSPCON( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSPCON_( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dspcon( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dspcon_( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSPEVD( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPEVD_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspevd( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspevd_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPEV( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void DSPEV_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void dspev( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void dspev_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void DSPEVX( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspevx( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspevx_( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPGST( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void DSPGST_( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void dspgst( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void dspgst_( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void DSPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspgvd( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPGV( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void DSPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void dspgv( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void dspgv_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void DSPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPOSV( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSPOSV_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsposv( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsposv_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSPRFS( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPRFS_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsprfs( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsprfs_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPSV( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void DSPSV_( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void dspsv( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void dspsv_( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void DSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPTRD( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void DSPTRD_( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void dsptrd( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void dsptrd_( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void DSPTRF( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void DSPTRF_( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void dsptrf( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void dsptrf_( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void DSPTRI( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void DSPTRI_( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void dsptri( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void dsptri_( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void DSPTRS( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void DSPTRS_( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void dsptrs( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void dsptrs_( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void DSTEBZ( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void DSTEBZ_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void dstebz( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void dstebz_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void DSTEDC( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEDC_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstedc( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstedc_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEGR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEGR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstegr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstegr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEIN( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSTEIN_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstein( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstein_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSTEMR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEMR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstemr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstemr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEQR( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTEQR_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dsteqr( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dsteqr_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTERF( const int* n, double* d, double* e, int* info ); void DSTERF_( const int* n, double* d, double* e, int* info ); void dsterf( const int* n, double* d, double* e, int* info ); void dsterf_( const int* n, double* d, double* e, int* info ); void DSTEVD( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEVD_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevd( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevd_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEV( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTEV_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dstev( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dstev_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTEVR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEVR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEVX( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSTEVX_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstevx( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstevx_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSYCON( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCON_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYEQUB( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void DSYEQUB_( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void dsyequb( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void dsyequb_( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void DSYEVD( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVD_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEV( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEV_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEVR( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVR_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVX( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYEVX_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYGS2( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGS2_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygs2( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygs2_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGST( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGST_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygst( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygst_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGVD( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsygvd( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsygvd_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYGV( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYGV_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsygvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsygvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYRFS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSYRFS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsyrfs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsyrfs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYSV( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void DSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void dsysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void dsysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void DSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYTD2( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void DSYTD2_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void dsytd2( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void dsytd2_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void DSYTF2( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTF2_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTRD( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void DSYTRD_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void dsytrd( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void dsytrd_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void DSYTRF( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRI_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DSYTRS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DTBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void DTBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void dtbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void dtbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void DTBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DTBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dtbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dtbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DTFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void DTFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void dtfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void dtfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void DTFTRI( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void DTFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void dtftri( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void dtftri_( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void DTFTTP( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void DTFTTP_( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void dtfttp( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void dtfttp_( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void DTFTTR( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void DTFTTR_( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void dtfttr( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void dtfttr_( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void DTGEVC( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTGEVC_( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtgevc( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtgevc_( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTGEX2( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void DTGEX2_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void dtgex2( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void dtgex2_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void DTGEXC( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void DTGEXC_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void dtgexc( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void dtgexc_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void DTGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void DTGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void dtgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void dtgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void DTGSNA( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void DTGSNA_( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void dtgsna( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void dtgsna_( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void DTGSY2( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void DTGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void dtgsy2( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void dtgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void DTGSYL( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void DTGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void dtgsyl( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void dtgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void DTPCON( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void DTPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void dtpcon( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void dtpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void DTPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTPTRI( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void DTPTRI_( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void dtptri( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void dtptri_( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void DTPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DTPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dtptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dtptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DTPTTF( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void DTPTTF_( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void dtpttf( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void dtpttf_( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void DTPTTR( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void DTPTTR_( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void dtpttr( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void dtpttr_( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void DTRCON( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void DTRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void dtrcon( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void dtrcon_( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void DTREVC( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTREVC_( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtrevc( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtrevc_( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTREXC( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void DTREXC_( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void dtrexc( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void dtrexc_( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void DTRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtrrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtrrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTRSEN( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTRSEN_( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtrsen( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtrsen_( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTRSNA( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void DTRSNA_( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void dtrsna( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void dtrsna_( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void DTRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void DTRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void dtrsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void dtrsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void DTRTI2( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTI2_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrti2( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrti2_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTRI( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTRI_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrtri( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrtri_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DTRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dtrtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dtrtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DTRTTF( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void DTRTTF_( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void dtrttf( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void dtrttf_( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void DTRTTP( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void DTRTTP_( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void dtrttp( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void dtrttp_( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void DTZRQF( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void DTZRQF_( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void dtzrqf( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void dtzrqf_( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void DTZRZF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DTZRZF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dtzrzf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dtzrzf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); double DZSUM1( const int* n, const MKL_Complex16* cx, const int* incx ); double DZSUM1_( const int* n, const MKL_Complex16* cx, const int* incx ); double dzsum1( const int* n, const MKL_Complex16* cx, const int* incx ); double dzsum1_( const int* n, const MKL_Complex16* cx, const int* incx ); int ICMAX1( const int* n, const MKL_Complex8* cx, const int* incx ); int ICMAX1_( const int* n, const MKL_Complex8* cx, const int* incx ); int icmax1( const int* n, const MKL_Complex8* cx, const int* incx ); int icmax1_( const int* n, const MKL_Complex8* cx, const int* incx ); int IEEECK( const int* ispec, const float* zero, const float* one ); int IEEECK_( const int* ispec, const float* zero, const float* one ); int ieeeck( const int* ispec, const float* zero, const float* one ); int ieeeck_( const int* ispec, const float* zero, const float* one ); int ILACLC( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILACLC_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclc( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclc_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILACLR( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILACLR_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclr( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclr_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILADIAG( const char* diag ); int ILADIAG_( const char* diag ); int iladiag( const char* diag ); int iladiag_( const char* diag ); int ILADLC( const int* m, const int* n, const double* a, const int* lda ); int ILADLC_( const int* m, const int* n, const double* a, const int* lda ); int iladlc( const int* m, const int* n, const double* a, const int* lda ); int iladlc_( const int* m, const int* n, const double* a, const int* lda ); int ILADLR( const int* m, const int* n, const double* a, const int* lda ); int ILADLR_( const int* m, const int* n, const double* a, const int* lda ); int iladlr( const int* m, const int* n, const double* a, const int* lda ); int iladlr_( const int* m, const int* n, const double* a, const int* lda ); int ILAENV( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ILAENV_( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ilaenv( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ilaenv_( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ILAPREC( const char* prec ); int ILAPREC_( const char* prec ); int ilaprec( const char* prec ); int ilaprec_( const char* prec ); int ILASLC( const int* m, const int* n, const float* a, const int* lda ); int ILASLC_( const int* m, const int* n, const float* a, const int* lda ); int ilaslc( const int* m, const int* n, const float* a, const int* lda ); int ilaslc_( const int* m, const int* n, const float* a, const int* lda ); int ILASLR( const int* m, const int* n, const float* a, const int* lda ); int ILASLR_( const int* m, const int* n, const float* a, const int* lda ); int ilaslr( const int* m, const int* n, const float* a, const int* lda ); int ilaslr_( const int* m, const int* n, const float* a, const int* lda ); int ILATRANS( const char* trans ); int ILATRANS_( const char* trans ); int ilatrans( const char* trans ); int ilatrans_( const char* trans ); int ILAUPLO( const char* uplo ); int ILAUPLO_( const char* uplo ); int ilauplo( const char* uplo ); int ilauplo_( const char* uplo ); void ILAVER( int* vers_major, int* vers_minor, int* vers_patch ); void ILAVER_( int* vers_major, int* vers_minor, int* vers_patch ); void ilaver( int* vers_major, int* vers_minor, int* vers_patch ); void ilaver_( int* vers_major, int* vers_minor, int* vers_patch ); int ILAZLC( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ILAZLC_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlc( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlc_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ILAZLR( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ILAZLR_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlr( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlr_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int IPARMQ( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int IPARMQ_( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int iparmq( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int iparmq_( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int IZMAX1( const int* n, const MKL_Complex16* cx, const int* incx ); int IZMAX1_( const int* n, const MKL_Complex16* cx, const int* incx ); int izmax1( const int* n, const MKL_Complex16* cx, const int* incx ); int izmax1_( const int* n, const MKL_Complex16* cx, const int* incx ); int LSAMEN( const int* n, const char* ca, const char* cb ); int LSAMEN_( const int* n, const char* ca, const char* cb ); int lsamen( const int* n, const char* ca, const char* cb ); int lsamen_( const int* n, const char* ca, const char* cb ); void SBDSDC( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void SBDSDC_( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void sbdsdc( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void sbdsdc_( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void SBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void SBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void sbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void sbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); float SCSUM1( const int* n, const MKL_Complex8* cx, const int* incx ); float SCSUM1_( const int* n, const MKL_Complex8* cx, const int* incx ); float scsum1( const int* n, const MKL_Complex8* cx, const int* incx ); float scsum1_( const int* n, const MKL_Complex8* cx, const int* incx ); void SDISNA( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); void SDISNA_( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); void sdisna( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); void sdisna_( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); float SECOND( void ); float SECOND_( void ); float second( void ); float second_( void ); void SGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void SGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void sgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void sgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void SGBCON( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgbcon( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequb( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequb_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBEQU( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequ( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequ_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void SGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void sgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void sgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void SGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBTF2( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTF2_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtf2( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtf2_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTRF( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTRF_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtrf( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtrf_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void SGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void sgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void sgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void SGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void SGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void sgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void sgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void SGEBAL( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void SGEBAL_( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void sgebal( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void sgebal_( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void SGEBD2( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void SGEBD2_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void sgebd2( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void sgebd2_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void SGEBRD( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void SGEBRD_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void sgebrd( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void sgebrd_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void SGECON( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGECON_( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgecon( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgecon_( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGEEQUB( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEEQUB_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequb( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequb_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEEQU( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEEQU_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequ( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequ_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEES( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void SGEES_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void sgees( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void sgees_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void SGEESX( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGEESX_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sgeesx( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sgeesx_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGEEV( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEEV_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgeev( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgeev_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void SGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void sgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void sgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void SGEGS( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void SGEGS_( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void sgegs( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void sgegs_( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void SGEGV( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEGV_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgegv( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgegv_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEHD2( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void SGEHD2_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void sgehd2( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void sgehd2_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void SGEHRD( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEHRD_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgehrd( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgehrd_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEJSV( const char* joba, char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void SGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void sgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void sgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void SGELQ2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGELQ2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgelq2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgelq2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGELQF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGELQF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgelqf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgelqf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGELSD( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void SGELSD_( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void sgelsd( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void sgelsd_( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void SGELS( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SGELS_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgels( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgels_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SGELSS( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGELSS_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelss( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelss_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGELSX( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void SGELSX_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void sgelsx( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void sgelsx_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void SGELSY( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGELSY_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelsy( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelsy_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGEQL2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQL2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeql2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeql2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQLF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQLF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqlf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqlf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQP3( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void SGEQP3_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void sgeqp3( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void sgeqp3_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void SGEQPF( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void SGEQPF_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void sgeqpf( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void sgeqpf_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void SGEQR2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQR2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQR2P( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQR2P_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2p( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2p_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQRF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQRF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQRFP( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQRFP_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrfp( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrfp_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGERFS( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGERFS_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgerfs( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgerfs_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGERQ2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGERQ2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgerq2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgerq2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGERQF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGERQF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgerqf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgerqf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGESC2( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void SGESC2_( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void sgesc2( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void sgesc2_( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void SGESDD( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void SGESDD_( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesdd( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesdd_( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void SGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void SGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void sgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void sgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void SGESV( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void SGESV_( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void sgesv( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void sgesv_( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void SGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void SGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void sgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void sgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void SGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGETC2( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void SGETC2_( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void sgetc2( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void sgetc2_( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void SGETF2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETF2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetf2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetf2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETRF( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETRF_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void MKL_SGETRFNPI( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void MKL_SGETRFNPI_( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void mkl_sgetrfnpi( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void mkl_sgetrfnpi_( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void SGETRI( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void SGETRI_( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void sgetri( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void sgetri_( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void SGETRS( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SGETRS_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void sgetrs( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void sgetrs_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void SGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void sggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void sggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void SGGBAL( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void SGGBAL_( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void sggbal( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void sggbal_( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void SGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void SGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void SGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGGEV( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGGEV_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void SGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void sggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void sggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void SGGGLM( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void SGGGLM_( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void sggglm( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void sggglm_( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void SGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void SGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void sgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void sgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void SGGLSE( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void SGGLSE_( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void sgglse( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void sgglse_( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void SGGQRF( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGQRF_( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggqrf( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggqrf_( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGRQF( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGRQF_( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggrqf( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggrqf_( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void SGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void sggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void sggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void SGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void SGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void sggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void sggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void SGSVJ0( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGSVJ0_( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj0( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj0_( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj1( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGTCON( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGTCON_( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgtcon( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgtcon_( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGTRFS( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTRFS_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtrfs( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtrfs_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTSV( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void SGTSV_( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void sgtsv( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void sgtsv_( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void SGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTTRF( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void SGTTRF_( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void sgttrf( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void sgttrf_( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void SGTTRS( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void SGTTRS_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void sgttrs( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void sgttrs_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void SGTTS2( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void SGTTS2_( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void sgtts2( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void sgtts2_( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void SHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SHSEIN( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void SHSEIN_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void shsein( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void shsein_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void SHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); int SISNAN( const float* sin ); int SISNAN_( const float* sin ); int sisnan( const float* sin ); int sisnan_( const float* sin ); void SLABAD( float* smallx, float* large ); void SLABAD_( float* smallx, float* large ); void slabad( float* smallx, float* large ); void slabad_( float* smallx, float* large ); void SLABRD( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void SLABRD_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void slabrd( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void slabrd_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void SLACN2( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void SLACN2_( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void slacn2( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void slacn2_( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void SLACON( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void SLACON_( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void slacon( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void slacon_( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void SLACPY( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void SLACPY_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void slacpy( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void slacpy_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void SLADIV( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void SLADIV_( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void sladiv( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void sladiv_( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void SLAE2( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void SLAE2_( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void slae2( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void slae2_( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void SLAEBZ( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void SLAEBZ_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void slaebz( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void slaebz_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void SLAED0( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void SLAED0_( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void slaed0( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void slaed0_( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void SLAED1( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void SLAED1_( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void slaed1( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void slaed1_( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void SLAED2( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void SLAED2_( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void slaed2( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void slaed2_( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void SLAED3( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void SLAED3_( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void slaed3( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void slaed3_( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void SLAED4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void SLAED4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void slaed4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void slaed4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void SLAED5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void SLAED5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void slaed5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void slaed5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void SLAED6( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void SLAED6_( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void slaed6( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void slaed6_( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void SLAED7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void SLAED7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void slaed7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void slaed7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void SLAED8( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void SLAED8_( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void slaed8( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void slaed8_( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void SLAED9( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void SLAED9_( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void slaed9( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void slaed9_( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void SLAEDA( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void SLAEDA_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void slaeda( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void slaeda_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void SLAEIN( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void SLAEIN_( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void slaein( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void slaein_( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void SLAEV2( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void SLAEV2_( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void slaev2( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void slaev2_( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void SLAEXC( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void SLAEXC_( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void slaexc( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void slaexc_( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void SLAG2D( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void SLAG2D_( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void slag2d( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void slag2d_( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void SLAG2( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void SLAG2_( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void slag2( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void slag2_( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void SLAGS2( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void SLAGS2_( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void slags2( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void slags2_( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void SLAGTF( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void SLAGTF_( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void slagtf( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void slagtf_( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void SLAGTM( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void SLAGTM_( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void slagtm( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void slagtm_( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void SLAGTS( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void SLAGTS_( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void slagts( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void slagts_( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void SLAGV2( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void SLAGV2_( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void slagv2( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void slagv2_( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void SLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void SLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void slahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void slahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void SLAHR2( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAHR2_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahr2( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahr2_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAHRD( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAHRD_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahrd( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahrd_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAIC1( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); void SLAIC1_( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); void slaic1( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); void slaic1_( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); int SLAISNAN( const float* sin1, const float* sin2 ); int SLAISNAN_( const float* sin1, const float* sin2 ); int slaisnan( const float* sin1, const float* sin2 ); int slaisnan_( const float* sin1, const float* sin2 ); void SLALN2( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void SLALN2_( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void slaln2( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void slaln2_( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void SLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void SLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void slals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void slals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void SLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void SLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void slalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void slalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void SLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); void SLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); void slalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); void slalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); float SLAMCH( const char* cmach ); float SLAMCH_( const char* cmach ); float slamch( const char* cmach ); float slamch_( const char* cmach ); void SLAMC1( int* beta, int* t, int* rnd, int* ieee1 ); void SLAMC1_( int* beta, int* t, int* rnd, int* ieee1 ); void slamc1( int* beta, int* t, int* rnd, int* ieee1 ); void slamc1_( int* beta, int* t, int* rnd, int* ieee1 ); void SLAMC2( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); void SLAMC2_( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); void slamc2( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); void slamc2_( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); float SLAMC3( const float* a, const float* b ); float SLAMC3_( const float* a, const float* b ); float slamc3( const float* a, const float* b ); float slamc3_( const float* a, const float* b ); void SLAMC4( int* emin, const float* start, const int* base ); void SLAMC4_( int* emin, const float* start, const int* base ); void slamc4( int* emin, const float* start, const int* base ); void slamc4_( int* emin, const float* start, const int* base ); void SLAMC5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void SLAMC5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void slamc5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void slamc5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void SLAMRG( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); void SLAMRG_( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); void slamrg( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); void slamrg_( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); int SLANEG( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); int SLANEG_( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); int slaneg( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); int slaneg_( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); float SLANGB( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float SLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float slangb( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float slangb_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float SLANGE( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float SLANGE_( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float slange( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float slange_( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float SLANGT( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float SLANGT_( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float slangt( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float slangt_( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float SLANHS( const char* norm, const int* n, const float* a, const int* lda, float* work ); float SLANHS_( const char* norm, const int* n, const float* a, const int* lda, float* work ); float slanhs( const char* norm, const int* n, const float* a, const int* lda, float* work ); float slanhs_( const char* norm, const int* n, const float* a, const int* lda, float* work ); float SLANSB( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slansb( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slansb_( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANSF( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float SLANSF_( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float slansf( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float slansf_( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float SLANSP( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float SLANSP_( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float slansp( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float slansp_( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float SLANST( const char* norm, const int* n, const float* d, const float* e ); float SLANST_( const char* norm, const int* n, const float* d, const float* e ); float slanst( const char* norm, const int* n, const float* d, const float* e ); float slanst_( const char* norm, const int* n, const float* d, const float* e ); float SLANSY( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float SLANSY_( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float slansy( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float slansy_( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float SLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float SLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float slantp( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float slantp_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float SLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); float SLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); float slantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); float slantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); void SLANV2( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void SLANV2_( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void slanv2( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void slanv2_( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void SLAPLL( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void SLAPLL_( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void slapll( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void slapll_( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void SLAPMT( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void SLAPMT_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmt( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmt_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); float SLAPY2( const float* x, const float* y ); float SLAPY2_( const float* x, const float* y ); float slapy2( const float* x, const float* y ); float slapy2_( const float* x, const float* y ); float SLAPY3( const float* x, const float* y, const float* z ); float SLAPY3_( const float* x, const float* y, const float* z ); float slapy3( const float* x, const float* y, const float* z ); float slapy3_( const float* x, const float* y, const float* z ); void SLAQGB( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQGB_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqgb( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqgb_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQGE( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQGE_( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqge( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqge_( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQP2( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void SLAQP2_( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void slaqp2( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void slaqp2_( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void SLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void SLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void slaqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void slaqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void SLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR1( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void SLAQR1_( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void slaqr1( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void slaqr1_( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void SLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void SLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void slaqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void slaqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void SLAQSB( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSB_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void slaqsb( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void slaqsb_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSP( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSP_( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void slaqsp( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void slaqsp_( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSY( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSY_( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void slaqsy( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void slaqsy_( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void SLAQTR( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void SLAQTR_( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void slaqtr( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void slaqtr_( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void SLAR1V( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void SLAR1V_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void slar1v( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void slar1v_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void SLAR2V( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void SLAR2V_( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void slar2v( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void slar2v_( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void SLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARF( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARF_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarf( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarf_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARFG( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFG_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfg( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfg_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFGP( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFGP_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfgp( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfgp_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFP( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFP_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfp( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfp_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFT( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLARFT_( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarft( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarft_( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLARFX( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void SLARFX_( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void slarfx( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void slarfx_( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void SLARGV( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void SLARGV_( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void slargv( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void slargv_( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void SLARNV( const int* idist, int* iseed, const int* n, float* x ); void SLARNV_( const int* idist, int* iseed, const int* n, float* x ); void slarnv( const int* idist, int* iseed, const int* n, float* x ); void slarnv_( const int* idist, int* iseed, const int* n, float* x ); void SLARRA( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void SLARRA_( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void slarra( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void slarra_( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void SLARRB( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void SLARRB_( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void slarrb( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void slarrb_( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void SLARRC( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void SLARRC_( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void slarrc( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void slarrc_( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void SLARRD( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void SLARRD_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void slarrd( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void slarrd_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void SLARRE( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void SLARRE_( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void slarre( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void slarre_( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void SLARRF( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void SLARRF_( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void slarrf( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void slarrf_( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void SLARRJ( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void SLARRJ_( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void slarrj( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void slarrj_( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void SLARRK( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void SLARRK_( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void slarrk( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void slarrk_( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void SLARRR( const int* n, const float* d, float* e, int* info ); void SLARRR_( const int* n, const float* d, float* e, int* info ); void slarrr( const int* n, const float* d, float* e, int* info ); void slarrr_( const int* n, const float* d, float* e, int* info ); void SLARRV( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void SLARRV_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void slarrv( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void slarrv_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void SLARSCL2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLARSCL2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slarscl2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slarscl2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLARTG( const float* f, const float* g, float* cs, float* sn, float* r ); void SLARTG_( const float* f, const float* g, float* cs, float* sn, float* r ); void slartg( const float* f, const float* g, float* cs, float* sn, float* r ); void slartg_( const float* f, const float* g, float* cs, float* sn, float* r ); void SLARTV( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void SLARTV_( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void slartv( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void slartv_( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void SLARUV( int* iseed, const int* n, float* x ); void SLARUV_( int* iseed, const int* n, float* x ); void slaruv( int* iseed, const int* n, float* x ); void slaruv_( int* iseed, const int* n, float* x ); void SLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARZ( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARZ_( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarz( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarz_( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARZT( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLARZT_( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarzt( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarzt_( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLAS2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void SLAS2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void slas2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void slas2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void SLASCL( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void SLASCL_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void slascl( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void slascl_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void SLASCL2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLASCL2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slascl2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slascl2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLASD0( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void SLASD0_( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void slasd0( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void slasd0_( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void SLASD1( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void SLASD1_( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void slasd1( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void slasd1_( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void SLASD2( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void SLASD2_( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void slasd2( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void slasd2_( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void SLASD3( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void SLASD3_( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void slasd3( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void slasd3_( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void SLASD4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void SLASD4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void slasd4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void slasd4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void SLASD5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void SLASD5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void slasd5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void slasd5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void SLASD6( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void SLASD6_( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void slasd6( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void slasd6_( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void SLASD7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void SLASD7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void slasd7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void slasd7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void SLASD8( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void SLASD8_( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void slasd8( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void slasd8_( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void SLASDA( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void SLASDA_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void slasda( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void slasda_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void SLASDQ( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void SLASDQ_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void slasdq( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void slasdq_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void SLASDT( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void SLASDT_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void slasdt( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void slasdt_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void SLASET( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void SLASET_( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void slaset( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void slaset_( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void SLASQ1( const int* n, float* d, float* e, float* work, int* info ); void SLASQ1_( const int* n, float* d, float* e, float* work, int* info ); void slasq1( const int* n, float* d, float* e, float* work, int* info ); void slasq1_( const int* n, float* d, float* e, float* work, int* info ); void SLASQ2( const int* n, float* z, int* info ); void SLASQ2_( const int* n, float* z, int* info ); void slasq2( const int* n, float* z, int* info ); void slasq2_( const int* n, float* z, int* info ); void SLASQ3( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void SLASQ3_( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void slasq3( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void slasq3_( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void SLASQ4( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void SLASQ4_( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void slasq4( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void slasq4_( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void SLASQ5( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void SLASQ5_( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void slasq5( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void slasq5_( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void SLASQ6( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void SLASQ6_( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void slasq6( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void slasq6_( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void SLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void SLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void slasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void slasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void SLASRT( const char* id, const int* n, float* d, int* info ); void SLASRT_( const char* id, const int* n, float* d, int* info ); void slasrt( const char* id, const int* n, float* d, int* info ); void slasrt_( const char* id, const int* n, float* d, int* info ); void SLASSQ( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void SLASSQ_( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void slassq( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void slassq_( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void SLASV2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void SLASV2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void slasv2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void slasv2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void SLASWP( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void SLASWP_( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void slaswp( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void slaswp_( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void SLASY2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void SLASY2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void slasy2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void slasy2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void SLASYF( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SLASYF_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void SLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void slatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void slatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void SLATDF( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void SLATDF_( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void slatdf( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void slatdf_( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void SLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void SLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void slatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void slatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void SLATRD( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void SLATRD_( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void slatrd( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void slatrd_( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void SLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void SLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void slatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void slatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void SLATRZ( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void SLATRZ_( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void slatrz( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void slatrz_( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void SLATZM( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void SLATZM_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void slatzm( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void slatzm_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void SLAUU2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SLAUU2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauu2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauu2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SLAUUM( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SLAUUM_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauum( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauum_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SOPGTR( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void SOPGTR_( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void sopgtr( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void sopgtr_( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void SOPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void SOPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void sopmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void sopmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORG2L( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORG2L_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2l( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2l_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORG2R( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORG2R_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2r( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2r_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGBR( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGBR_( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgbr( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgbr_( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGHR( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGHR_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorghr( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorghr_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGL2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGL2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgl2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgl2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGLQ( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGLQ_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorglq( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorglq_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQL( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQL_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgql( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgql_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQR( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQR_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgqr( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgqr_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGR2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGR2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgr2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgr2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGRQ( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGRQ_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgrq( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgrq_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGTR( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGTR_( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgtr( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgtr_( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormql( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SPBCON( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPBCON_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spbcon( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spbcon_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPBEQU( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void SPBEQU_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void spbequ( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void spbequ_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void SPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBSTF( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBSTF_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbstf( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbstf_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBTF2( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTF2_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtf2( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtf2_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTRF( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTRF_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtrf( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtrf_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPFTRF( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRF_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftrf( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftrf_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRI( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRI_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftri( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftri_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void SPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void spftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void spftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void SPOCON( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPOCON_( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spocon( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spocon_( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPOEQUB( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPOEQUB_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequb( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequb_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPOEQU( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPOEQU_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequ( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequ_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPORFS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPORFS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sporfs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sporfs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPOSV( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void SPOSV_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void sposv( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void sposv_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void SPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPOTF2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTF2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotf2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotf2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRF( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRF_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRI( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRI_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotri( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotri_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void SPOTRS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void spotrs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void spotrs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void SPPCON( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPPCON_( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sppcon( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sppcon_( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPPEQU( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void SPPEQU_( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void sppequ( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void sppequ_( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void SPPRFS( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPRFS_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spprfs( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spprfs_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPSV( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void SPPSV_( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void sppsv( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void sppsv_( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void SPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPTRF( const char* uplo, const int* n, float* ap, int* info ); void SPPTRF_( const char* uplo, const int* n, float* ap, int* info ); void spptrf( const char* uplo, const int* n, float* ap, int* info ); void spptrf_( const char* uplo, const int* n, float* ap, int* info ); void SPPTRI( const char* uplo, const int* n, float* ap, int* info ); void SPPTRI_( const char* uplo, const int* n, float* ap, int* info ); void spptri( const char* uplo, const int* n, float* ap, int* info ); void spptri_( const char* uplo, const int* n, float* ap, int* info ); void SPPTRS( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void SPPTRS_( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void spptrs( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void spptrs_( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void SPSTF2( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPSTF2_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstf2( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstf2_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPSTRF( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPSTRF_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstrf( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstrf_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPTCON( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void SPTCON_( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void sptcon( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void sptcon_( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void SPTEQR( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SPTEQR_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void spteqr( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void spteqr_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SPTRFS( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void SPTRFS_( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void sptrfs( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void sptrfs_( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void SPTSV( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void SPTSV_( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void sptsv( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void sptsv_( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void SPTSVX( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void SPTSVX_( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void sptsvx( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void sptsvx_( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void SPTTRF( const int* n, float* d, float* e, int* info ); void SPTTRF_( const int* n, float* d, float* e, int* info ); void spttrf( const int* n, float* d, float* e, int* info ); void spttrf_( const int* n, float* d, float* e, int* info ); void SPTTRS( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void SPTTRS_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void spttrs( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void spttrs_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void SPTTS2( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void SPTTS2_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void sptts2( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void sptts2_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void SRSCL( const int* n, const float* sa, float* sx, const int* incx ); void SRSCL_( const int* n, const float* sa, float* sx, const int* incx ); void srscl( const int* n, const float* sa, float* sx, const int* incx ); void srscl_( const int* n, const float* sa, float* sx, const int* incx ); void SSBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEV( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void SSBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void ssbev( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void ssbev_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void SSBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void SSBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void ssbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void ssbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void SSBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void SSBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void ssbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void ssbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void SSBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBTRD( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void SSBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void ssbtrd( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void ssbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void SSFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void SSFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void ssfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void ssfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void SSPCON( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSPCON_( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sspcon( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sspcon_( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSPEVD( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPEVD_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspevd( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspevd_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPEV( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void SSPEV_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void sspev( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void sspev_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void SSPEVX( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspevx( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspevx_( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPGST( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void SSPGST_( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void sspgst( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void sspgst_( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void SSPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspgvd( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPGV( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void SSPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void sspgv( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void sspgv_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void SSPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPRFS( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPRFS_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssprfs( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssprfs_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPSV( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void SSPSV_( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void sspsv( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void sspsv_( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void SSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPTRD( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void SSPTRD_( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void ssptrd( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void ssptrd_( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void SSPTRF( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void SSPTRF_( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void ssptrf( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void ssptrf_( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void SSPTRI( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void SSPTRI_( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void ssptri( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void ssptri_( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void SSPTRS( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void SSPTRS_( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void ssptrs( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void ssptrs_( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void SSTEBZ( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void SSTEBZ_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void sstebz( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void sstebz_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void SSTEDC( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEDC_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstedc( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstedc_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEGR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEGR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstegr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstegr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEIN( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSTEIN_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstein( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstein_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSTEMR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEMR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstemr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstemr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEQR( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTEQR_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void ssteqr( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void ssteqr_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTERF( const int* n, float* d, float* e, int* info ); void SSTERF_( const int* n, float* d, float* e, int* info ); void ssterf( const int* n, float* d, float* e, int* info ); void ssterf_( const int* n, float* d, float* e, int* info ); void SSTEVD( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEVD_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevd( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevd_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEV( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTEV_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void sstev( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void sstev_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTEVR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEVR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEVX( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSTEVX_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstevx( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstevx_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSYCON( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCON_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYEQUB( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void SSYEQUB_( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void ssyequb( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void ssyequb_( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void SSYEVD( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVD_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEV( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEV_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEVR( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVR_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVX( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYEVX_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYGS2( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGS2_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygs2( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygs2_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGST( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGST_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygst( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygst_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGVD( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssygvd( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssygvd_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYGV( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYGV_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssygvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssygvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYRFS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSYRFS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssyrfs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssyrfs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYSV( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void SSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void ssysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void ssysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void SSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYTD2( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void SSYTD2_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void ssytd2( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void ssytd2_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void SSYTF2( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTF2_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTRD( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void SSYTRD_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void ssytrd( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void ssytrd_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void SSYTRF( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRI_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SSYTRS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void STBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void STBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void stbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void stbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void STBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void STBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void stbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void stbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void STFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void STFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void stfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void stfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void STFTRI( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void STFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void stftri( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void stftri_( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void STFTTP( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void STFTTP_( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void stfttp( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void stfttp_( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void STFTTR( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void STFTTR_( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void stfttr( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void stfttr_( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void STGEVC( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STGEVC_( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void stgevc( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void stgevc_( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STGEX2( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void STGEX2_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void stgex2( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void stgex2_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void STGEXC( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void STGEXC_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void stgexc( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void stgexc_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void STGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void stgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void stgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void STGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void stgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void stgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void STGSNA( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void STGSNA_( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void stgsna( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void stgsna_( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void STGSY2( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void STGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void stgsy2( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void stgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void STGSYL( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void STGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void stgsyl( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void stgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void STPCON( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void STPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void stpcon( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void stpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void STPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STPTRI( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void STPTRI_( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void stptri( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void stptri_( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void STPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void STPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void stptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void stptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void STPTTF( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void STPTTF_( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void stpttf( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void stpttf_( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void STPTTR( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void STPTTR_( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void stpttr( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void stpttr_( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void STRCON( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void STRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void strcon( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void strcon_( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void STREVC( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STREVC_( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void strevc( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void strevc_( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STREXC( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void STREXC_( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void strexc( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void strexc_( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void STRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void strrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void strrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STRSEN( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STRSEN_( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void strsen( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void strsen_( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STRSNA( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void STRSNA_( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void strsna( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void strsna_( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void STRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void STRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void strsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void strsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void STRTI2( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTI2_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strti2( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strti2_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTRI( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTRI_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strtri( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strtri_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void STRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void strtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void strtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void STRTTF( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void STRTTF_( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void strttf( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void strttf_( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void STRTTP( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void STRTTP_( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void strttp( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void strttp_( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void STZRQF( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void STZRQF_( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void stzrqf( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void stzrqf_( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void STZRZF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void STZRZF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void stzrzf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void stzrzf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void XERBLA_ARRAY( const char* srname_array, const int* srname_len, const int* info ); void XERBLA_ARRAY_( const char* srname_array, const int* srname_len, const int* info ); void xerbla_array( const char* srname_array, const int* srname_len, const int* info ); void xerbla_array_( const char* srname_array, const int* srname_len, const int* info ); void ZBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void ZBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void zbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void zbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void ZCGESV( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZCGESV_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcgesv( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcgesv_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZCPOSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZCPOSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcposv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcposv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZDRSCL( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void ZDRSCL_( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void zdrscl( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void zdrscl_( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void ZGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void ZGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void zgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void zgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void ZGBCON( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgbcon( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequb( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequb_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBEQU( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequ( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequ_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBTF2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTF2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtf2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtf2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTRF( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTRF_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtrf( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtrf_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGEBAL( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void ZGEBAL_( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void zgebal( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void zgebal_( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void ZGEBD2( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void ZGEBD2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void zgebd2( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void zgebd2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void ZGEBRD( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void ZGEBRD_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void zgebrd( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void zgebrd_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void ZGECON( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGECON_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgecon( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgecon_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGEEQUB( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEEQUB_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequb( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequb_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEEQU( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEEQU_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequ( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequ_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEES( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEES_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgees( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgees_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEESX( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEESX_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgeesx( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgeesx_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGS( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGS_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegs( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegs_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegv( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegv_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEHD2( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEHD2_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgehd2( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgehd2_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEHRD( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEHRD_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgehrd( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgehrd_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGELQ2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGELQ2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgelq2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgelq2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGELQF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGELQF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgelqf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgelqf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGELSD( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGELSD_( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgelsd( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgelsd_( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGELS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZGELS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgels( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgels_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZGELSS( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGELSS_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelss( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelss_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGELSX( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void ZGELSX_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void zgelsx( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void zgelsx_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void ZGELSY( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGELSY_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelsy( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelsy_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEQL2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQL2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeql2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeql2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQLF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQLF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqlf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqlf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQP3( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEQP3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeqp3( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeqp3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEQPF( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void ZGEQPF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void zgeqpf( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void zgeqpf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void ZGEQR2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQR2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQR2P( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQR2P_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2p( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2p_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQRF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQRF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQRFP( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQRFP_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrfp( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrfp_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGERFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGERFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgerfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgerfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGERQ2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGERQ2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgerq2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgerq2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGERQF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGERQF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgerqf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgerqf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGESC2( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void ZGESC2_( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void zgesc2( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void zgesc2_( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void ZGESDD( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGESDD_( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgesdd( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgesdd_( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGESV( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGESV_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgesv( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgesv_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGETC2( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void ZGETC2_( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void zgetc2( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void zgetc2_( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void ZGETF2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETF2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetf2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetf2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETRF( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETRF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void MKL_ZGETRFNPI( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void MKL_ZGETRFNPI_( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnpi( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnpi_( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void ZGETRI( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZGETRI_( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zgetri( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zgetri_( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZGETRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGETRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgetrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgetrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGGBAL( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void ZGGBAL_( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void zggbal( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void zggbal_( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void ZGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void ZGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void zggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void zggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void ZGGEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGGEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void ZGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void zggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void zggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void ZGGGLM( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void ZGGGLM_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void zggglm( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void zggglm_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void ZGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void ZGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void zgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void zgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void ZGGLSE( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void ZGGLSE_( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void zgglse( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void zgglse_( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void ZGGQRF( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGQRF_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggqrf( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggqrf_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGRQF( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGRQF_( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggrqf( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggrqf_( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGTCON( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZGTCON_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zgtcon( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zgtcon_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZGTRFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTRFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtrfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtrfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTSV( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZGTSV_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zgtsv( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zgtsv_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTTRF( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void ZGTTRF_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void zgttrf( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void zgttrf_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void ZGTTRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGTTRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgttrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgttrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGTTS2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void ZGTTS2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void zgtts2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void zgtts2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void ZHBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEV( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbev( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbev_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void ZHBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void zhbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void zhbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void ZHBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBTRD( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZHBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zhbtrd( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zhbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZHECON( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHECON_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHEEQUB( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZHEEQUB_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zheequb( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zheequb_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZHEEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEV( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEVR( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVR_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEGS2( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGS2_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegs2( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegs2_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGST( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGST_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegst( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegst_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhegvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhegvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhegvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhegvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHERFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHERFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zherfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zherfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHERFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHERFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zherfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zherfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHESV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHESVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhesvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhesvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHESVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHESVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zhesvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zhesvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHETD2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHETD2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void zhetd2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void zhetd2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHETF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETRD( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRI_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHETRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void ZHFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void zhfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void zhfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void ZHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHPCON( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHPCON_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhpcon( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhpcon_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHPEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpevd( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPEV( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpev( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpev_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPGST( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void ZHPGST_( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void zhpgst( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void zhpgst_( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void ZHPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpgvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpgv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpgv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhpsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhpsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhpsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhpsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPTRD( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHPTRD_( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void zhptrd( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void zhptrd_( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHPTRF( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZHPTRF_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zhptrf( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zhptrf_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZHPTRI( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZHPTRI_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zhptri( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zhptri_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZHPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHSEIN( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void ZHSEIN_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void zhsein( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void zhsein_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void ZHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zhseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zhseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLABRD( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void ZLABRD_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void zlabrd( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void zlabrd_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void ZLACGV( const int* n, MKL_Complex16* x, const int* incx ); void ZLACGV_( const int* n, MKL_Complex16* x, const int* incx ); void zlacgv( const int* n, MKL_Complex16* x, const int* incx ); void zlacgv_( const int* n, MKL_Complex16* x, const int* incx ); void ZLACN2( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void ZLACN2_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void zlacn2( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void zlacn2_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void ZLACON( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void ZLACON_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void zlacon( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void zlacon_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void ZLACP2( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACP2_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacp2( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacp2_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACPY( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACPY_( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacpy( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacpy_( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACRM( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLACRM_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlacrm( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlacrm_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLACRT( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void ZLACRT_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void zlacrt( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void zlacrt_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void ZLADIV( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void ZLADIV_( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void zladiv( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void zladiv_( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void ZLAED0( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void ZLAED0_( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void zlaed0( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void zlaed0_( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void ZLAED7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZLAED7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlaed7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlaed7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZLAED8( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void ZLAED8_( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void zlaed8( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void zlaed8_( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void ZLAEIN( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void ZLAEIN_( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void zlaein( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void zlaein_( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void ZLAESY( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void ZLAESY_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void zlaesy( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void zlaesy_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void ZLAEV2( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void ZLAEV2_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void zlaev2( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void zlaev2_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void ZLAG2C( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLAG2C_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlag2c( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlag2c_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLAGS2( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void ZLAGS2_( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void zlags2( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void zlags2_( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void ZLAGTM( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void ZLAGTM_( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void zlagtm( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void zlagtm_( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void ZLAHEF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHEF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void ZLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void zlahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void zlahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void ZLAHR2( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAHR2_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahr2( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahr2_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAHRD( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAHRD_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahrd( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahrd_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAIC1( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void ZLAIC1_( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void zlaic1( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void zlaic1_( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void ZLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void ZLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void zlals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void zlals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void ZLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void ZLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void zlalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void zlalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void ZLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); double ZLANGB( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double zlangb( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double zlangb_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANGE( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANGE_( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlange( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlange_( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANGT( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double ZLANGT_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double zlangt( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double zlangt_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double ZLANHB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANHB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlanhb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlanhb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANHE( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHE_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhe( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhe_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHF( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double ZLANHF_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double zlanhf( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double zlanhf_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double ZLANHP( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANHP_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlanhp( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlanhp_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANHS( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHS_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhs( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhs_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHT( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double ZLANHT_( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double zlanht( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double zlanht_( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double ZLANSB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlansb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlansb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANSP( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANSP_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlansp( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlansp_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANSY( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANSY_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlansy( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlansy_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double ZLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double zlantp( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double zlantp_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double ZLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); void ZLAPLL( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void ZLAPLL_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void zlapll( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void zlapll_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void ZLAPMT( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void ZLAPMT_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmt( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmt_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void ZLAQGB( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQGB_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqgb( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqgb_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQGE( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQGE_( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqge( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqge_( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQHB( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void ZLAQHB_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void zlaqhb( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void zlaqhb_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void ZLAQHE( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQHE_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhe( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhe_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQHP( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQHP_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhp( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhp_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQP2( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void ZLAQP2_( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void zlaqp2( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void zlaqp2_( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void ZLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void ZLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void zlaqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void zlaqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void ZLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR1( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void ZLAQR1_( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void zlaqr1( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void zlaqr1_( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void ZLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void ZLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void zlaqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void zlaqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void ZLAQSB( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSB_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsb( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsb_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSP( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSP_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsp( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsp_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSY( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSY_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsy( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsy_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAR1V( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void ZLAR1V_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void zlar1v( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void zlar1v_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void ZLAR2V( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void ZLAR2V_( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void zlar2v( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void zlar2v_( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void ZLARCM( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLARCM_( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlarcm( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlarcm_( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARF( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARF_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarf( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarf_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARFG( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFG_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfg( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfg_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFGP( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFGP_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfgp( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfgp_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFP( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFP_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfp( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfp_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFT( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLARFT_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarft( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarft_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLARFX( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARFX_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfx( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfx_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARGV( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void ZLARGV_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void zlargv( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void zlargv_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void ZLARNV( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void ZLARNV_( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void zlarnv( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void zlarnv_( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void ZLARRV( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void ZLARRV_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void zlarrv( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void zlarrv_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void ZLARSCL2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLARSCL2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlarscl2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlarscl2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLARTG( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void ZLARTG_( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void zlartg( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void zlartg_( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void ZLARTV( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void ZLARTV_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void zlartv( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void zlartv_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void ZLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARZ( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARZ_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarz( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarz_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARZT( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLARZT_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarzt( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarzt_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLASCL( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLASCL_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlascl( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlascl_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLASCL2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLASCL2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlascl2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlascl2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLASET( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void ZLASET_( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void zlaset( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void zlaset_( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void ZLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void ZLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void zlasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void zlasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void ZLASSQ( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void ZLASSQ_( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void zlassq( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void zlassq_( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void ZLASWP( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void ZLASWP_( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void zlaswp( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void zlaswp_( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void ZLASYF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAT2C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLAT2C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlat2c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlat2c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATDF( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void ZLATDF_( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void zlatdf( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void zlatdf_( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void ZLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATRD( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void ZLATRD_( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void zlatrd( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void zlatrd_( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void ZLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATRZ( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void ZLATRZ_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void zlatrz( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void zlatrz_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void ZLATZM( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void ZLATZM_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void zlatzm( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void zlatzm_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void ZLAUU2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLAUU2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauu2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauu2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLAUUM( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLAUUM_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauum( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauum_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPBCON( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPBCON_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpbcon( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpbcon_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPBEQU( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void ZPBEQU_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void zpbequ( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void zpbequ_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void ZPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBSTF( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBSTF_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbstf( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbstf_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBTF2( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTF2_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtf2( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtf2_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTRF( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTRF_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtrf( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtrf_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPFTRF( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRF_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftrf( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftrf_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRI( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRI_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftri( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftri_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void ZPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void zpftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void zpftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void ZPOCON( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPOCON_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpocon( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpocon_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPOEQUB( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPOEQUB_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequb( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequb_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPOEQU( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPOEQU_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequ( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequ_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPORFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPORFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zporfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zporfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPOSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPOSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zposv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zposv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPOTF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRI( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRI_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotri( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotri_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPOTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zpotrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zpotrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPPCON( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPPCON_( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zppcon( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zppcon_( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPPEQU( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void ZPPEQU_( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void zppequ( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void zppequ_( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void ZPPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zppsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zppsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPTRF( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRF_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptrf( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptrf_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRI( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRI_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptri( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptri_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zpptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zpptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPSTF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPSTF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPSTRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPSTRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPTCON( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void ZPTCON_( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void zptcon( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void zptcon_( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void ZPTEQR( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZPTEQR_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zpteqr( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zpteqr_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZPTRFS( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTRFS_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptrfs( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptrfs_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTSV( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTSV_( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zptsv( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zptsv_( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTSVX( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTSVX_( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptsvx( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptsvx_( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTTRF( const int* n, double* d, MKL_Complex16* e, int* info ); void ZPTTRF_( const int* n, double* d, MKL_Complex16* e, int* info ); void zpttrf( const int* n, double* d, MKL_Complex16* e, int* info ); void zpttrf_( const int* n, double* d, MKL_Complex16* e, int* info ); void ZPTTRS( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTTRS_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zpttrs( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zpttrs_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTTS2( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void ZPTTS2_( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void zptts2( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void zptts2_( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void ZROT( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void ZROT_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void zrot( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void zrot_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void ZSPCON( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSPCON_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zspcon( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zspcon_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSPMV( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSPMV_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zspmv( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zspmv_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSPR( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void ZSPR_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void zspr( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void zspr_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void ZSPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zspsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zspsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPTRF( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZSPTRF_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zsptrf( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zsptrf_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZSPTRI( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZSPTRI_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zsptri( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zsptri_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZSPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSTEDC( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZSTEDC_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zstedc( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zstedc_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZSTEGR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEGR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstegr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstegr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEIN( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void ZSTEIN_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void zstein( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void zstein_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void ZSTEMR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEMR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstemr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstemr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEQR( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZSTEQR_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zsteqr( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zsteqr_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZSYCON( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCON_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYEQUB( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZSYEQUB_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zsyequb( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zsyequb_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZSYMV( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSYMV_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zsymv( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zsymv_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSYR( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void ZSYR_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void zsyr( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void zsyr_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void ZSYRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSYRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsyrfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsyrfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zsysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zsysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYTF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRI_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZTBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZTBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ztbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ztbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZTFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ZTFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ztfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ztfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ZTFTRI( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ZTFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ztftri( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ztftri_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ZTFTTP( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ZTFTTP_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ztfttp( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ztfttp_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ZTFTTR( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ZTFTTR_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ztfttr( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ztfttr_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ZTGEVC( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTGEVC_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztgevc( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztgevc_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTGEX2( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ZTGEX2_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ztgex2( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ztgex2_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ZTGEXC( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ZTGEXC_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ztgexc( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ztgexc_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ZTGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZTGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ztgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ztgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZTGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ZTGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ztgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ztgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ZTGSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTGSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTGSY2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ZTGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ztgsy2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ztgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ZTGSYL( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsyl( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTPCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztpcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTPTRI( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ZTPTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ztptri( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ztptri_( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ZTPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZTPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ztptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ztptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZTPTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ZTPTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ztpttf( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ztpttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ZTPTTR( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ZTPTTR_( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ztpttr( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ztpttr_( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ZTRCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztrcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztrcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTREVC( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTREVC_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztrevc( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztrevc_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTREXC( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ZTREXC_( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ztrexc( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ztrexc_( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ZTRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztrrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztrrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTRSEN( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ZTRSEN_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ztrsen( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ztrsen_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ZTRSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ZTRSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ztrsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ztrsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ZTRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ZTRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ztrsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ztrsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ZTRTI2( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTI2_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrti2( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrti2_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTRI( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrtri( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrtri_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZTRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ztrtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ztrtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZTRTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ZTRTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ztrttf( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ztrttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ZTRTTP( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ZTRTTP_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ztrttp( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ztrttp_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ZTZRQF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ZTZRQF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ztzrqf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ztzrqf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ZTZRZF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZTZRZF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ztzrzf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ztzrzf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNG2L( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNG2L_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2l( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2l_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNG2R( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNG2R_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2r( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2r_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGBR( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGBR_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungbr( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungbr_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGHR( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGHR_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunghr( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunghr_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGL2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGL2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungl2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungl2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGLQ( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGLQ_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunglq( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunglq_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQL( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQL_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungql( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungql_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQR( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQR_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungqr( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungqr_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGR2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGR2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungr2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungr2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGRQ( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGRQ_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungrq( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungrq_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGTR( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGTR_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungtr( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungtr_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmql( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUPGTR( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZUPGTR_( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zupgtr( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zupgtr_( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZUPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zupmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zupmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void CGEQRT2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGEQRT2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CHESWAPR( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void CHESWAPR_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void cheswapr( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void cheswapr_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void CHETRI2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI2X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CHETRI2X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri2x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri2x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_GBRCOND_C( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GBRCOND_C_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_c( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_c_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GBRCOND_X( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_GBRCOND_X_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_x( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_x_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); float CLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); float cla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); float cla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); void CLA_GEAMV( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_GEAMV_( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_geamv( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_geamv_( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_GERCOND_C( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GERCOND_C_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_c( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_c_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GERCOND_X( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_GERCOND_X_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_x( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_x_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_GERPVGRW( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); float CLA_GERPVGRW_( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); float cla_gerpvgrw( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); float cla_gerpvgrw_( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); void CLA_HEAMV( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_HEAMV_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_heamv( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_heamv_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_HERCOND_C( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_HERCOND_C_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_c( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_c_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_HERCOND_X( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_HERCOND_X_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_x( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_x_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_HERFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_HERFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_herfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_herfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_HERPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float CLA_HERPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_herpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_herpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); void CLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); void CLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); void cla_lin_berr( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); void cla_lin_berr_( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); float CLA_PORCOND_C( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_PORCOND_C_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_c( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_c_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_PORCOND_X( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_PORCOND_X_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_x( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_x_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_PORPVGRW( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); float CLA_PORPVGRW_( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); float cla_porpvgrw( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); float cla_porpvgrw_( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); void CLA_SYAMV( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_SYAMV_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_syamv( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_syamv_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_SYRCOND_C( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_SYRCOND_C_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_c( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_c_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_SYRCOND_X( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_SYRCOND_X_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_x( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_x_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float CLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_syrpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_syrpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); void CLA_WWADDW( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void CLA_WWADDW_( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void cla_wwaddw( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void cla_wwaddw_( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void CTPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void CTPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void ctprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void ctprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void DGEQRT2( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGEQRT2_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt2( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt2_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void DLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); double DLA_GBRCOND( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_GBRCOND_( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gbrcond( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gbrcond_( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); double DLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); double dla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); double dla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); void DLA_GEAMV( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void DLA_GEAMV_( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_geamv( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_geamv_( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); double DLA_GERCOND( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_GERCOND_( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gercond( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gercond_( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_GERPVGRW( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); double DLA_GERPVGRW_( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); double dla_gerpvgrw( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); double dla_gerpvgrw_( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); void DLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); void DLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); void dla_lin_berr( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); void dla_lin_berr_( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); double DLA_PORCOND( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_PORCOND_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_porcond( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_porcond_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_PORPVGRW( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); double DLA_PORPVGRW_( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); double dla_porpvgrw( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); double dla_porpvgrw_( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); void DLA_SYAMV( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void DLA_SYAMV_( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_syamv( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_syamv_( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); double DLA_SYRCOND( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_SYRCOND_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_syrcond( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_syrcond_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); double DLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); double dla_syrpvgrw( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); double dla_syrpvgrw_( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); void DLA_WWADDW( const int* n, double* x, double* y, const double* w ); void DLA_WWADDW_( const int* n, double* x, double* y, const double* w ); void dla_wwaddw( const int* n, double* x, double* y, const double* w ); void dla_wwaddw_( const int* n, double* x, double* y, const double* w ); void DTPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void DTPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void dtprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void dtprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void SGEQRT2( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGEQRT2_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt2( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt2_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void SLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); float SLA_GBRCOND( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_GBRCOND_( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gbrcond( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gbrcond_( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); float SLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); float sla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); float sla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); void SLA_GEAMV( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void SLA_GEAMV_( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_geamv( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_geamv_( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); float SLA_GERCOND( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_GERCOND_( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gercond( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gercond_( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_GERPVGRW( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); float SLA_GERPVGRW_( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); float sla_gerpvgrw( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); float sla_gerpvgrw_( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); void SLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); void SLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); void sla_lin_berr( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); void sla_lin_berr_( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); float SLA_PORCOND( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_PORCOND_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_porcond( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_porcond_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_PORPVGRW( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); float SLA_PORPVGRW_( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); float sla_porpvgrw( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); float sla_porpvgrw_( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); void SLA_SYAMV( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void SLA_SYAMV_( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_syamv( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_syamv_( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); float SLA_SYRCOND( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_SYRCOND_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_syrcond( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_syrcond_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); float SLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); float sla_syrpvgrw( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); float sla_syrpvgrw_( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); void SLA_WWADDW( const int* n, float* x, float* y, const float* w ); void SLA_WWADDW_( const int* n, float* x, float* y, const float* w ); void sla_wwaddw( const int* n, float* x, float* y, const float* w ); void sla_wwaddw_( const int* n, float* x, float* y, const float* w ); void STPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void STPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void stprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void stprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void ZGEQRT2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGEQRT2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZHESWAPR( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void ZHESWAPR_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zheswapr( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zheswapr_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void ZHETRI2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI2X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZHETRI2X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri2x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri2x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_GBRCOND_C( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GBRCOND_C_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_c( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_c_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GBRCOND_X( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GBRCOND_X_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_x( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_x_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); double ZLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); double zla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); double zla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); void ZLA_GEAMV( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_GEAMV_( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_geamv( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_geamv_( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_GERCOND_C( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GERCOND_C_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_c( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_c_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GERCOND_X( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GERCOND_X_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_x( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_x_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_GERPVGRW( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); double ZLA_GERPVGRW_( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); double zla_gerpvgrw( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); double zla_gerpvgrw_( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); void ZLA_HEAMV( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_HEAMV_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_heamv( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_heamv_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_HERCOND_C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_HERCOND_C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_HERCOND_X( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_HERCOND_X_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_x( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_x_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_HERFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_HERFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_herfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_herfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_HERPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double ZLA_HERPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_herpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_herpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); void ZLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); void ZLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); void zla_lin_berr( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); void zla_lin_berr_( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); double ZLA_PORCOND_C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_PORCOND_C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_PORCOND_X( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_PORCOND_X_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_x( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_x_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_PORPVGRW( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); double ZLA_PORPVGRW_( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); double zla_porpvgrw( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); double zla_porpvgrw_( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); void ZLA_SYAMV( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_SYAMV_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_syamv( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_syamv_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_SYRCOND_C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_SYRCOND_C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_SYRCOND_X( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_SYRCOND_X_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_x( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_x_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double ZLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_syrpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_syrpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); void ZLA_WWADDW( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void ZLA_WWADDW_( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void zla_wwaddw( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void zla_wwaddw_( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void ZTPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void ZTPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void ztprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void ztprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void CHERDB( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CHERDB_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cherdb( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cherdb_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void DSYRDB( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DSYRDB_( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsyrdb( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsyrdb_( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void SSYRDB( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SSYRDB_( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssyrdb( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssyrdb_( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ZHERDB( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZHERDB_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zherdb( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zherdb_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void CDTSVB( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CDTSVB_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdtsvb( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdtsvb_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CDTTRFB( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void CDTTRFB_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void cdttrfb( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void cdttrfb_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void CDTTRSB( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CDTTRSB_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdttrsb( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdttrsb_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void DDTSVB( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void DDTSVB_( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void ddtsvb( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void ddtsvb_( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void DDTTRFB( const int* n, double* dl, double* d, const double* du, int* info ); void DDTTRFB_( const int* n, double* dl, double* d, const double* du, int* info ); void ddttrfb( const int* n, double* dl, double* d, const double* du, int* info ); void ddttrfb_( const int* n, double* dl, double* d, const double* du, int* info ); void DDTTRSB( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void DDTTRSB_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void ddttrsb( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void ddttrsb_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void SDTSVB( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void SDTSVB_( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void sdtsvb( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void sdtsvb_( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void SDTTRFB( const int* n, float* dl, float* d, const float* du, int* info ); void SDTTRFB_( const int* n, float* dl, float* d, const float* du, int* info ); void sdttrfb( const int* n, float* dl, float* d, const float* du, int* info ); void sdttrfb_( const int* n, float* dl, float* d, const float* du, int* info ); void SDTTRSB( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void SDTTRSB_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void sdttrsb( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void sdttrsb_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void ZDTSVB( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZDTSVB_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdtsvb( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdtsvb_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZDTTRFB( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void ZDTTRFB_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void zdttrfb( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void zdttrfb_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void ZDTTRSB( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZDTTRSB_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdttrsb( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdttrsb_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void MKL_CTPPACK( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void MKL_CTPPACK_( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void mkl_ctppack( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void mkl_ctppack_( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void MKL_DTPPACK( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void MKL_DTPPACK_( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void mkl_dtppack( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void mkl_dtppack_( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void MKL_STPPACK( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void MKL_STPPACK_( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void mkl_stppack( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void mkl_stppack_( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void MKL_ZTPPACK( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void MKL_ZTPPACK_( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void mkl_ztppack( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void mkl_ztppack_( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void MKL_CTPUNPACK( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void MKL_CTPUNPACK_( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void mkl_ctpunpack( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void mkl_ctpunpack_( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void MKL_DTPUNPACK( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void MKL_DTPUNPACK_( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void mkl_dtpunpack( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void mkl_dtpunpack_( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void MKL_STPUNPACK( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void MKL_STPUNPACK_( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void mkl_stpunpack( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void mkl_stpunpack_( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void MKL_ZTPUNPACK( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void MKL_ZTPUNPACK_( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void mkl_ztpunpack( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void mkl_ztpunpack_( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void DLATM1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void DLATM1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void dlatm1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void dlatm1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void SLATM1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void SLATM1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void slatm1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void slatm1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void CLATM1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void CLATM1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void clatm1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void clatm1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void ZLATM1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); void ZLATM1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); void zlatm1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); void zlatm1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); double DLATM2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); double DLATM2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); double dlatm2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); double dlatm2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); float SLATM2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); float SLATM2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); float slatm2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); float slatm2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); void CLATM2( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void CLATM2_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void clatm2( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void clatm2_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void ZLATM2( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); void ZLATM2_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); void zlatm2( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); void zlatm2_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); double DLATM3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); double DLATM3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); double dlatm3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); double dlatm3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); float SLATM3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); float SLATM3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); float slatm3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); float slatm3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); void CLATM3( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void CLATM3_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void clatm3( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void clatm3_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void ZLATM3( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void ZLATM3_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void zlatm3( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void zlatm3_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void DLATM5( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void DLATM5_( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void dlatm5( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void dlatm5_( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void SLATM5( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void SLATM5_( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void slatm5( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void slatm5_( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void CLATM5( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void CLATM5_( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void clatm5( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void clatm5_( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void ZLATM5( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void ZLATM5_( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void zlatm5( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void zlatm5_( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void DLATM6( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void DLATM6_( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void dlatm6( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void dlatm6_( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void SLATM6( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void SLATM6_( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void slatm6( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void slatm6_( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void CLATM6( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void CLATM6_( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void clatm6( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void clatm6_( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void ZLATM6( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void ZLATM6_( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void zlatm6( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void zlatm6_( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void DLATME( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void DLATME_( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void dlatme( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void dlatme_( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void SLATME( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void SLATME_( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void slatme( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void slatme_( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void CLATME( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void CLATME_( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatme( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatme_( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void ZLATME( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void ZLATME_( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatme( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatme_( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void DLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void DLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void dlatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void dlatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void SLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void SLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void slatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void slatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void CLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void CLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void clatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void clatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void ZLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void ZLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void zlatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void zlatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void DLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void DLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void dlatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void dlatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void SLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void SLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void slatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void slatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void CLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void CLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void ZLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void ZLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void DLAKF2( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void DLAKF2_( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void dlakf2( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void dlakf2_( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void SLAKF2( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void SLAKF2_( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void slakf2( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void slakf2_( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void CLAKF2( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void CLAKF2_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void clakf2( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void clakf2_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void ZLAKF2( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void ZLAKF2_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void zlakf2( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void zlakf2_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void DLARGE( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void DLARGE_( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void dlarge( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void dlarge_( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void SLARGE( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void SLARGE_( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void slarge( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void slarge_( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void CLARGE( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLARGE_( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clarge( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clarge_( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void ZLARGE( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLARGE_( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlarge( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlarge_( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); double DLARND( const int* idist, int* iseed ); double DLARND_( const int* idist, int* iseed ); double dlarnd( const int* idist, int* iseed ); double dlarnd_( const int* idist, int* iseed ); float SLARND( const int* idist, int* iseed ); float SLARND_( const int* idist, int* iseed ); float slarnd( const int* idist, int* iseed ); float slarnd_( const int* idist, int* iseed ); void CLARND( MKL_Complex8* retval, const int* idist, int* iseed ); void CLARND_( MKL_Complex8* retval, const int* idist, int* iseed ); void clarnd( MKL_Complex8* retval, const int* idist, int* iseed ); void clarnd_( MKL_Complex8* retval, const int* idist, int* iseed ); void ZLARND( MKL_Complex16* retval, const int* idist, int* iseed ); void ZLARND_( MKL_Complex16* retval, const int* idist, int* iseed ); void zlarnd( MKL_Complex16* retval, const int* idist, int* iseed ); void zlarnd_( MKL_Complex16* retval, const int* idist, int* iseed ); void DLAROR( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void DLAROR_( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void dlaror( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void dlaror_( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void SLAROR( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void SLAROR_( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void slaror( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void slaror_( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void CLAROR( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void CLAROR_( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void claror( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void claror_( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void ZLAROR( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void ZLAROR_( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void zlaror( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void zlaror_( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void DLAROT( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void DLAROT_( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void dlarot( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void dlarot_( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void SLAROT( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void SLAROT_( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void slarot( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void slarot_( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void CLAROT( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void CLAROT_( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void clarot( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void clarot_( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void ZLAROT( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); void ZLAROT_( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); void zlarot( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); void zlarot_( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); double DLARAN( int* iseed ); double DLARAN_( int* iseed ); double dlaran( int* iseed ); double dlaran_( int* iseed ); float SLARAN( int* iseed ); float SLARAN_( int* iseed ); float slaran( int* iseed ); float slaran_( int* iseed ); void DLAGGE( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void DLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagge( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagge_( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void SLAGGE( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void SLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagge( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagge_( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void CLAGGE( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagge( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagge_( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void ZLAGGE( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagge( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagge_( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void CLAGSY( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLAGSY_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagsy( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagsy_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void DLAGSY( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void DLAGSY_( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagsy( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagsy_( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void SLAGSY( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void SLAGSY_( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagsy( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagsy_( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void ZLAGSY( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLAGSY_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagsy( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagsy_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void CLAGHE( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLAGHE_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void claghe( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void claghe_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void ZLAGHE( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLAGHE_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlaghe( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlaghe_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void MKL_CSPFFRT2( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrt2( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrt2_( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void MKL_CSPFFRTX( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrtx( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrtx_( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void MKL_DSPFFRT2( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrt2( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrt2_( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void MKL_DSPFFRTX( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrtx( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrtx_( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void MKL_SSPFFRT2( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrt2( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrt2_( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void MKL_SSPFFRTX( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrtx( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrtx_( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void MKL_ZSPFFRT2( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrt2( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrt2_( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void MKL_ZSPFFRTX( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrtx( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrtx_( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); int MKL_PROGRESS( int* thread, int* step, char* stage, int lstage ); int MKL_PROGRESS_( int* thread, int* step, char* stage, int lstage ); int mkl_progress( int* thread, int* step, char* stage, int lstage ); int mkl_progress_( int* thread, int* step, char* stage, int lstage ); #line 44 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_lapacke.h" typedef int (*LAPACK_S_SELECT2) ( const float*, const float* ); typedef int (*LAPACK_S_SELECT3) ( const float*, const float*, const float* ); typedef int (*LAPACK_D_SELECT2) ( const double*, const double* ); typedef int (*LAPACK_D_SELECT3) ( const double*, const double*, const double* ); typedef int (*LAPACK_C_SELECT1) ( const MKL_Complex8* ); typedef int (*LAPACK_C_SELECT2) ( const MKL_Complex8*, const MKL_Complex8* ); typedef int (*LAPACK_Z_SELECT1) ( const MKL_Complex16* ); typedef int (*LAPACK_Z_SELECT2) ( const MKL_Complex16*, const MKL_Complex16* ); double LAPACKE_dlamch( char cmach ); double LAPACKE_dlamch_work( char cmach ); double LAPACKE_dlange( int matrix_layout, char norm, int m, int n, const double* a, int lda ); double LAPACKE_dlange_work( int matrix_layout, char norm, int m, int n, const double* a, int lda, double* work ); double LAPACKE_dlansy( int matrix_layout, char norm, char uplo, int n, const double* a, int lda ); double LAPACKE_dlansy_work( int matrix_layout, char norm, char uplo, int n, const double* a, int lda, double* work ); double LAPACKE_dlantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const double* a, int lda ); double LAPACKE_dlantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const double* a, int lda, double* work ); double LAPACKE_dlapy2( double x, double y ); double LAPACKE_dlapy2_work( double x, double y ); double LAPACKE_dlapy3( double x, double y, double z ); double LAPACKE_dlapy3_work( double x, double y, double z ); double LAPACKE_zlange( int matrix_layout, char norm, int m, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlange_work( int matrix_layout, char norm, int m, int n, const MKL_Complex16* a, int lda, double* work ); double LAPACKE_zlanhe( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlanhe_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda, double* work ); int LAPACKE_zlarcm( int matrix_layout, int m, int n, const double* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc ); int LAPACKE_zlarcm_work( int matrix_layout, int m, int n, const double* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, double* work ); int LAPACKE_zlacrm( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, const double* b, int ldb, MKL_Complex16* c, int ldc ); int LAPACKE_zlacrm_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, const double* b, int ldb, MKL_Complex16* c, int ldc, double* work ); double LAPACKE_zlansy( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlansy_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda, double* work ); double LAPACKE_zlantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex16* a, int lda, double* work ); float LAPACKE_clange( int matrix_layout, char norm, int m, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clange_work( int matrix_layout, char norm, int m, int n, const MKL_Complex8* a, int lda, float* work ); float LAPACKE_clanhe( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clanhe_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda, float* work ); int LAPACKE_clarcm( int matrix_layout, int m, int n, const float* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc ); int LAPACKE_clarcm_work( int matrix_layout, int m, int n, const float* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, float* rwork ); int LAPACKE_clacrm( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, const float* b, int ldb, MKL_Complex8* c, int ldc ); int LAPACKE_clacrm_work( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, const float* b, int ldb, MKL_Complex8* c, int ldc, float* rwork ); float LAPACKE_clansy( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clansy_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda, float* work ); float LAPACKE_clantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex8* a, int lda, float* work ); float LAPACKE_slamch( char cmach ); float LAPACKE_slamch_work( char cmach ); float LAPACKE_slange( int matrix_layout, char norm, int m, int n, const float* a, int lda ); float LAPACKE_slange_work( int matrix_layout, char norm, int m, int n, const float* a, int lda, float* work ); float LAPACKE_slansy( int matrix_layout, char norm, char uplo, int n, const float* a, int lda ); float LAPACKE_slansy_work( int matrix_layout, char norm, char uplo, int n, const float* a, int lda, float* work ); float LAPACKE_slantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const float* a, int lda ); float LAPACKE_slantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const float* a, int lda, float* work ); float LAPACKE_slapy2( float x, float y ); float LAPACKE_slapy2_work( float x, float y ); float LAPACKE_slapy3( float x, float y, float z ); float LAPACKE_slapy3_work( float x, float y, float z ); int LAPACKE_cbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e ); int LAPACKE_cbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, int lrwork ); int LAPACKE_cbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, MKL_Complex8* vt, int ldvt, MKL_Complex8* u, int ldu, MKL_Complex8* c, int ldc ); int LAPACKE_cbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, MKL_Complex8* vt, int ldvt, MKL_Complex8* u, int ldu, MKL_Complex8* c, int ldc, float* work ); int LAPACKE_cgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq, MKL_Complex8* pt, int ldpt, MKL_Complex8* c, int ldc ); int LAPACKE_cgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq, MKL_Complex8* pt, int ldpt, MKL_Complex8* c, int ldc, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbcon( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, const int* ipiv, float anorm, float* rcond ); int LAPACKE_cgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbequ( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbequb( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_cgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbtrf( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex8* ab, int ldab, int* ipiv ); int LAPACKE_cgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex8* ab, int ldab, int* ipiv ); int LAPACKE_cgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cgebal( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_cgebal_work( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_cgebrd( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup ); int LAPACKE_cgebrd_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int lwork ); int LAPACKE_cgecon( int matrix_layout, char norm, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond ); int LAPACKE_cgecon_work( int matrix_layout, char norm, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cgeequ( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgeequ_work( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgeequb( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgeequb_work( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgees( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs ); int LAPACKE_cgees_work( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cgeesx( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, char sense, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs, float* rconde, float* rcondv ); int LAPACKE_cgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, char sense, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cgeev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr ); int LAPACKE_cgeev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv ); int LAPACKE_cgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgehrd( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgehrd_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex8* a, int lda, float* sva, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, float* stat, int* istat ); int LAPACKE_cgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex8* a, int lda, float* sva, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* cwork, int lwork, float* rwork, int lrwork, int* iwork ); int LAPACKE_cgelq2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgelq2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work ); int LAPACKE_cgelqf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgelqf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgels( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cgels_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_cgelsd( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_cgelsd_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cgelss( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_cgelss_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgelsy( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* jpvt, float rcond, int* rank ); int LAPACKE_cgelsy_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* jpvt, float rcond, int* rank, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc ); int LAPACKE_cgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_cgeqlf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqlf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqp3( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau ); int LAPACKE_cgeqp3_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgeqpf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau ); int LAPACKE_cgeqpf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork ); int LAPACKE_cgeqr2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqr2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work ); int LAPACKE_cgeqrf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqrf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqrfp( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqrfp_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqrt( int matrix_layout, int m, int n, int nb, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt3( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt3_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt_work( int matrix_layout, int m, int n, int nb, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt, MKL_Complex8* work ); int LAPACKE_cgerfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cgerfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgerqf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgerqf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgesdd( int matrix_layout, char jobz, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt ); int LAPACKE_cgesdd_work( int matrix_layout, char jobz, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cgesv( int matrix_layout, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgesv_work( int matrix_layout, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, float* superb ); int LAPACKE_cgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, int* superb ); int LAPACKE_cgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex8 * a, int lda, float* sva, int mv, MKL_Complex8* v, int ldv, float* stat ); int LAPACKE_cgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex8* a, int lda, float* sva, int mv, MKL_Complex8* v, int ldv, MKL_Complex8* cwork, int lwork, float* rwork, int lrwork ); int LAPACKE_cgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_cgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgetf2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetf2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetri( int matrix_layout, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_cgetri_work( int matrix_layout, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_cgetrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgetrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cggbal( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale ); int LAPACKE_cggbal_work( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work ); int LAPACKE_cgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr ); int LAPACKE_cgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr ); int LAPACKE_cgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, float* rconde, float* rcondv ); int LAPACKE_cggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int liwork, int* bwork ); int LAPACKE_cggev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr ); int LAPACKE_cggev3( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr ); int LAPACKE_cggev3_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cggev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv ); int LAPACKE_cggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* bwork ); int LAPACKE_cggglm( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y ); int LAPACKE_cggglm_work( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, int lwork ); int LAPACKE_cgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_cgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork ); int LAPACKE_cgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_cgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_cgglse( int matrix_layout, int m, int n, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x ); int LAPACKE_cgglse_work( int matrix_layout, int m, int n, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, int lwork ); int LAPACKE_cggqrf( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub ); int LAPACKE_cggqrf_work( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub, MKL_Complex8* work, int lwork ); int LAPACKE_cggrqf( int matrix_layout, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub ); int LAPACKE_cggrqf_work( int matrix_layout, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub, MKL_Complex8* work, int lwork ); int LAPACKE_cggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork ); int LAPACKE_cggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork ); int LAPACKE_cggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, MKL_Complex8* work, float* rwork, int* iwork ); int LAPACKE_cggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq ); int LAPACKE_cggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq ); int LAPACKE_cggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work ); int LAPACKE_cgtcon( char norm, int n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, float anorm, float* rcond ); int LAPACKE_cgtcon_work( char norm, int n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_cgtrfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgtsv( int matrix_layout, int n, int nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, int ldb ); int LAPACKE_cgtsv_work( int matrix_layout, int n, int nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, int ldb ); int LAPACKE_cgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgttrf( int n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv ); int LAPACKE_cgttrf_work( int n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv ); int LAPACKE_cgttrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgttrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chbev( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chbevd( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, const MKL_Complex8* bb, int ldbb, MKL_Complex8* x, int ldx ); int LAPACKE_chbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, const MKL_Complex8* bb, int ldbb, MKL_Complex8* x, int ldx, MKL_Complex8* work, float* rwork ); int LAPACKE_chbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chbtrd( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq ); int LAPACKE_chbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq, MKL_Complex8* work ); int LAPACKE_checon( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond ); int LAPACKE_checon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_cheequb( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cheequb_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax, MKL_Complex8* work ); int LAPACKE_cheev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cheevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevr( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz ); int LAPACKE_cheevr_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_cheevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_chegst( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb ); int LAPACKE_chegst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb ); int LAPACKE_chegv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w ); int LAPACKE_chegv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chegvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w ); int LAPACKE_chegvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chegvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chegvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_cherfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cherfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cherfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cherfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_chesv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chesv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_chesvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_chesvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chesvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_chesvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cheswapr( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_cheswapr_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_chetrd( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tau ); int LAPACKE_chetrd_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_chetrf_rook( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_chetrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetri( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_chetri2( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_chetri2_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetri2x( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, int nb ); int LAPACKE_chetri2x_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int nb ); int LAPACKE_chetri_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work ); int LAPACKE_chetrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work ); int LAPACKE_chetrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const MKL_Complex8* a, int lda, float beta, MKL_Complex8* c ); int LAPACKE_chfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const MKL_Complex8* a, int lda, float beta, MKL_Complex8* c ); int LAPACKE_chgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* t, int ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_chgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* t, int ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chpcon( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond ); int LAPACKE_chpcon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_chpev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chpevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chpevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chpevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chpgst( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* ap, const MKL_Complex8* bp ); int LAPACKE_chpgst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* ap, const MKL_Complex8* bp ); int LAPACKE_chpgv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chpgvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chpgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chpgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_chprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_chpsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chpsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chpsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_chpsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_chptrd( int matrix_layout, char uplo, int n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau ); int LAPACKE_chptrd_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau ); int LAPACKE_chptrf( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_chptrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_chptri( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv ); int LAPACKE_chptri_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work ); int LAPACKE_chptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chsein( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_chsein_work( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr ); int LAPACKE_chseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* z, int ldz ); int LAPACKE_chseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork ); int LAPACKE_clacgv( int n, MKL_Complex8* x, int incx ); int LAPACKE_clacgv_work( int n, MKL_Complex8* x, int incx ); int LAPACKE_clacn2( int n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); int LAPACKE_clacn2_work( int n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); int LAPACKE_clacp2( int matrix_layout, char uplo, int m, int n, const float* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clacp2_work( int matrix_layout, char uplo, int m, int n, const float* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clacpy( int matrix_layout, char uplo, int m, int n, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clacpy_work( int matrix_layout, char uplo, int m, int n, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clag2z( int matrix_layout, int m, int n, const MKL_Complex8* sa, int ldsa, MKL_Complex16* a, int lda ); int LAPACKE_clag2z_work( int matrix_layout, int m, int n, const MKL_Complex8* sa, int ldsa, MKL_Complex16* a, int lda ); int LAPACKE_clagge( int matrix_layout, int m, int n, int kl, int ku, const float* d, MKL_Complex8* a, int lda, int* iseed ); int LAPACKE_clagge_work( int matrix_layout, int m, int n, int kl, int ku, const float* d, MKL_Complex8* a, int lda, int* iseed, MKL_Complex8* work ); int LAPACKE_claghe( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed ); int LAPACKE_claghe_work( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed, MKL_Complex8* work ); int LAPACKE_clagsy( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed ); int LAPACKE_clagsy_work( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed, MKL_Complex8* work ); int LAPACKE_clapmr( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clapmr_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clapmt( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clapmt_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc ); int LAPACKE_clarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc, MKL_Complex8* work, int ldwork ); int LAPACKE_clarfg( int n, MKL_Complex8* alpha, MKL_Complex8* x, int incx, MKL_Complex8* tau ); int LAPACKE_clarfg_work( int n, MKL_Complex8* alpha, MKL_Complex8* x, int incx, MKL_Complex8* tau ); int LAPACKE_clarft( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* tau, MKL_Complex8* t, int ldt ); int LAPACKE_clarft_work( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* tau, MKL_Complex8* t, int ldt ); int LAPACKE_clarfx( int matrix_layout, char side, int m, int n, const MKL_Complex8* v, MKL_Complex8 tau, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_clarfx_work( int matrix_layout, char side, int m, int n, const MKL_Complex8* v, MKL_Complex8 tau, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_clarnv( int idist, int* iseed, int n, MKL_Complex8* x ); int LAPACKE_clarnv_work( int idist, int* iseed, int n, MKL_Complex8* x ); int LAPACKE_clascl( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_clascl_work( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_claset( int matrix_layout, char uplo, int m, int n, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8* a, int lda ); int LAPACKE_claset_work( int matrix_layout, char uplo, int m, int n, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8* a, int lda ); int LAPACKE_claswp( int matrix_layout, int n, MKL_Complex8* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_claswp_work( int matrix_layout, int n, MKL_Complex8* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_clatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, MKL_Complex8* a, int lda ); int LAPACKE_clatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, MKL_Complex8* a, int lda, MKL_Complex8* work ); int LAPACKE_clauum( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_clauum_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpbcon( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float anorm, float* rcond ); int LAPACKE_cpbcon_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cpbequ( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_cpbequ_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_cpbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cpbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpbstf( int matrix_layout, char uplo, int n, int kb, MKL_Complex8* bb, int ldbb ); int LAPACKE_cpbstf_work( int matrix_layout, char uplo, int n, int kb, MKL_Complex8* bb, int ldbb ); int LAPACKE_cpbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cpbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpbtrf( int matrix_layout, char uplo, int n, int kd, MKL_Complex8* ab, int ldab ); int LAPACKE_cpbtrf_work( int matrix_layout, char uplo, int n, int kd, MKL_Complex8* ab, int ldab ); int LAPACKE_cpbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpftrf( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftrf_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftri( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftri_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_cpftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_cpocon( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond ); int LAPACKE_cpocon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cpoequ( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cpoequ_work( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cpoequb( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cpoequb_work( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cporfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cporfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cposv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cposv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cpotrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrf2( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrf2_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotri( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotri_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cpotrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cppcon( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float anorm, float* rcond ); int LAPACKE_cppcon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cppequ( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float* s, float* scond, float* amax ); int LAPACKE_cppequ_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float* s, float* scond, float* amax ); int LAPACKE_cpprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cpprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cppsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cppsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpptrf( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptri( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptri_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cpptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cpstrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* piv, int* rank, float tol ); int LAPACKE_cpstrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* piv, int* rank, float tol, float* work ); int LAPACKE_cptcon( int n, const float* d, const MKL_Complex8* e, float anorm, float* rcond ); int LAPACKE_cptcon_work( int n, const float* d, const MKL_Complex8* e, float anorm, float* rcond, float* work ); int LAPACKE_cpteqr( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz ); int LAPACKE_cpteqr_work( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz, float* work ); int LAPACKE_cptrfs( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cptrfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cptsv( int matrix_layout, int n, int nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cptsv_work( int matrix_layout, int n, int nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cptsvx( int matrix_layout, char fact, int n, int nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cptsvx_work( int matrix_layout, char fact, int n, int nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpttrf( int n, float* d, MKL_Complex8* e ); int LAPACKE_cpttrf_work( int n, float* d, MKL_Complex8* e ); int LAPACKE_cpttrs( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cpttrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cspcon( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond ); int LAPACKE_cspcon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_csprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_csprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cspsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cspsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_csptrf( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_csptrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_csptri( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv ); int LAPACKE_csptri_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work ); int LAPACKE_csptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cstedc( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz ); int LAPACKE_cstedc_work( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cstegr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz ); int LAPACKE_cstegr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_cstein( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, int ldz, int* ifailv ); int LAPACKE_cstein_work( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, int ldz, float* work, int* iwork, int* ifailv ); int LAPACKE_cstemr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, MKL_Complex8* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_cstemr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, MKL_Complex8* z, int ldz, int nzc, int* isuppz, int* tryrac, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_csteqr( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz ); int LAPACKE_csteqr_work( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz, float* work ); int LAPACKE_csycon( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond ); int LAPACKE_csycon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_csyconv( int matrix_layout, char uplo, char way, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* e ); int LAPACKE_csyconv_work( int matrix_layout, char uplo, char way, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* e ); int LAPACKE_csyequb( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_csyequb_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax, MKL_Complex8* work ); int LAPACKE_csyr( int matrix_layout, char uplo, int n, MKL_Complex8 alpha, const MKL_Complex8* x, int incx, MKL_Complex8* a, int lda ); int LAPACKE_csyr_work( int matrix_layout, char uplo, int n, MKL_Complex8 alpha, const MKL_Complex8* x, int incx, MKL_Complex8* a, int lda ); int LAPACKE_csyrfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_csyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_csyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_csyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_csysv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_rook( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csysv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_csysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_csysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_csysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_csyswapr( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_csyswapr_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_csytrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_csytrf_rook( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_csytrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytri( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_csytri2( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_csytri2_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytri2x( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, int nb ); int LAPACKE_csytri2x_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int nb ); int LAPACKE_csytri_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work ); int LAPACKE_csytrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work ); int LAPACKE_csytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_ctbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex8* ab, int ldab, float* rcond ); int LAPACKE_ctbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex8* ab, int ldab, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_ctbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_ctbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_ctbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_ctbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_ctfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex8 alpha, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_ctfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex8 alpha, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_ctftri( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex8* a ); int LAPACKE_ctftri_work( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex8* a ); int LAPACKE_ctfttp( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* ap ); int LAPACKE_ctfttp_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* ap ); int LAPACKE_ctfttr( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* a, int lda ); int LAPACKE_ctfttr_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* a, int lda ); int LAPACKE_ctgevc( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex8* s, int lds, const MKL_Complex8* p, int ldp, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m ); int LAPACKE_ctgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex8* s, int lds, const MKL_Complex8* p, int ldp, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, MKL_Complex8* work, float* rwork ); int LAPACKE_ctgexc( int matrix_layout, int wantq, int wantz, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int ifst, int ilst ); int LAPACKE_ctgexc_work( int matrix_layout, int wantq, int wantz, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int ifst, int ilst ); int LAPACKE_ctgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int* m, float* pl, float* pr, float* dif ); int LAPACKE_ctgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, int lwork, int* iwork, int liwork ); int LAPACKE_ctgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* ncycle ); int LAPACKE_ctgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, MKL_Complex8* work, int* ncycle ); int LAPACKE_ctgsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* dif, int mm, int* m ); int LAPACKE_ctgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* dif, int mm, int* m, MKL_Complex8* work, int lwork, int* iwork ); int LAPACKE_ctgsyl( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, const MKL_Complex8* d, int ldd, const MKL_Complex8* e, int lde, MKL_Complex8* f, int ldf, float* scale, float* dif ); int LAPACKE_ctgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, const MKL_Complex8* d, int ldd, const MKL_Complex8* e, int lde, MKL_Complex8* f, int ldf, float* scale, float* dif, MKL_Complex8* work, int lwork, int* iwork ); int LAPACKE_ctpcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* ap, float* rcond ); int LAPACKE_ctpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_ctpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work ); int LAPACKE_ctpqrt( int matrix_layout, int m, int n, int l, int nb, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt ); int LAPACKE_ctpqrt2( int matrix_layout, int m, int n, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt ); int LAPACKE_ctpqrt2_work( int matrix_layout, int m, int n, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt ); int LAPACKE_ctpqrt_work( int matrix_layout, int m, int n, int l, int nb, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt, MKL_Complex8* work ); int LAPACKE_ctprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work, int ldwork ); int LAPACKE_ctprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_ctprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_ctptri( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* ap ); int LAPACKE_ctptri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* ap ); int LAPACKE_ctptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_ctptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_ctpttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* arf ); int LAPACKE_ctpttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* arf ); int LAPACKE_ctpttr( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* a, int lda ); int LAPACKE_ctpttr_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* a, int lda ); int LAPACKE_ctrcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* a, int lda, float* rcond ); int LAPACKE_ctrcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* a, int lda, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_ctrevc( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m ); int LAPACKE_ctrevc_work( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, MKL_Complex8* work, float* rwork ); int LAPACKE_ctrexc( int matrix_layout, char compq, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, int ifst, int ilst ); int LAPACKE_ctrexc_work( int matrix_layout, char compq, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, int ifst, int ilst ); int LAPACKE_ctrrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_ctrrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_ctrsen( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, MKL_Complex8* w, int* m, float* s, float* sep ); int LAPACKE_ctrsen_work( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, int lwork ); int LAPACKE_ctrsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* t, int ldt, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* sep, int mm, int* m ); int LAPACKE_ctrsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* t, int ldt, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* sep, int mm, int* m, MKL_Complex8* work, int ldwork, float* rwork ); int LAPACKE_ctrsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, float* scale ); int LAPACKE_ctrsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, float* scale ); int LAPACKE_ctrtri( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* a, int lda ); int LAPACKE_ctrtri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* a, int lda ); int LAPACKE_ctrtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctrtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctrttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* arf ); int LAPACKE_ctrttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* arf ); int LAPACKE_ctrttp( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* ap ); int LAPACKE_ctrttp_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* ap ); int LAPACKE_ctzrzf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_ctzrzf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunbdb( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2 ); int LAPACKE_cunbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, int lwork ); int LAPACKE_cuncsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t ); int LAPACKE_cuncsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x21, int ldx21, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t ); int LAPACKE_cuncsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x21, int ldx21, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork ); int LAPACKE_cuncsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork ); int LAPACKE_cungbr( int matrix_layout, char vect, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungbr_work( int matrix_layout, char vect, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunghr( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cunghr_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunglq( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cunglq_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungql( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungql_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungqr( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungqr_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungrq( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungrq_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungtr( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungtr_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunmbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmql( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmql_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmrq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cupgtr( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, int ldq ); int LAPACKE_cupgtr_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, int ldq, MKL_Complex8* work ); int LAPACKE_cupmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cupmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_dbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e ); int LAPACKE_dbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* work, int lwork ); int LAPACKE_dbdsdc( int matrix_layout, char uplo, char compq, int n, double* d, double* e, double* u, int ldu, double* vt, int ldvt, double* q, int* iq ); int LAPACKE_dbdsdc_work( int matrix_layout, char uplo, char compq, int n, double* d, double* e, double* u, int ldu, double* vt, int ldvt, double* q, int* iq, double* work, int* iwork ); int LAPACKE_dbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, double* vt, int ldvt, double* u, int ldu, double* c, int ldc ); int LAPACKE_dbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, double* vt, int ldvt, double* u, int ldu, double* c, int ldc, double* work ); int LAPACKE_dbdsvdx( int matrix_layout, char uplo, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* ns, double* s, double* z, int ldz, int* superb ); int LAPACKE_dbdsvdx_work( int matrix_layout, char uplo, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* ns, double* s, double* z, int ldz, double* work, int* iwork ); int LAPACKE_ddisna( char job, int m, int n, const double* d, double* sep ); int LAPACKE_ddisna_work( char job, int m, int n, const double* d, double* sep ); int LAPACKE_dgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, double* ab, int ldab, double* d, double* e, double* q, int ldq, double* pt, int ldpt, double* c, int ldc ); int LAPACKE_dgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, double* ab, int ldab, double* d, double* e, double* q, int ldq, double* pt, int ldpt, double* c, int ldc, double* work ); int LAPACKE_dgbcon( int matrix_layout, char norm, int n, int kl, int ku, const double* ab, int ldab, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const double* ab, int ldab, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dgbequ( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbequb( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, double* ab, int ldab, int* ipiv, double* b, int ldb ); int LAPACKE_dgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, double* ab, int ldab, int* ipiv, double* b, int ldb ); int LAPACKE_dgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_dgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgbtrf( int matrix_layout, int m, int n, int kl, int ku, double* ab, int ldab, int* ipiv ); int LAPACKE_dgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, double* ab, int ldab, int* ipiv ); int LAPACKE_dgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const int* ipiv, double* b, int ldb ); int LAPACKE_dgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const int* ipiv, double* b, int ldb ); int LAPACKE_dgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, double* v, int ldv ); int LAPACKE_dgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, double* v, int ldv ); int LAPACKE_dgebal( int matrix_layout, char job, int n, double* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_dgebal_work( int matrix_layout, char job, int n, double* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_dgebrd( int matrix_layout, int m, int n, double* a, int lda, double* d, double* e, double* tauq, double* taup ); int LAPACKE_dgebrd_work( int matrix_layout, int m, int n, double* a, int lda, double* d, double* e, double* tauq, double* taup, double* work, int lwork ); int LAPACKE_dgecon( int matrix_layout, char norm, int n, const double* a, int lda, double anorm, double* rcond ); int LAPACKE_dgecon_work( int matrix_layout, char norm, int n, const double* a, int lda, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dgeequ( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgeequ_work( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgeequb( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgeequb_work( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgees( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs ); int LAPACKE_dgees_work( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs, double* work, int lwork, int* bwork ); int LAPACKE_dgeesx( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, char sense, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs, double* rconde, double* rcondv ); int LAPACKE_dgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, char sense, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs, double* rconde, double* rcondv, double* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_dgeev( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr ); int LAPACKE_dgeev_work( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr, double* work, int lwork ); int LAPACKE_dgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv ); int LAPACKE_dgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, int lwork, int* iwork ); int LAPACKE_dgehrd( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, double* tau ); int LAPACKE_dgehrd_work( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, double* a, int lda, double* sva, double* u, int ldu, double* v, int ldv, double* stat, int* istat ); int LAPACKE_dgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, double* a, int lda, double* sva, double* u, int ldu, double* v, int ldv, double* work, int lwork, int* iwork ); int LAPACKE_dgelq2( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgelq2_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work ); int LAPACKE_dgelqf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgelqf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgels( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dgels_work( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* work, int lwork ); int LAPACKE_dgelsd( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_dgelsd_work( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank, double* work, int lwork, int* iwork ); int LAPACKE_dgelss( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_dgelss_work( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank, double* work, int lwork ); int LAPACKE_dgelsy( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, int* jpvt, double rcond, int* rank ); int LAPACKE_dgelsy_work( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, int* jpvt, double rcond, int* rank, double* work, int lwork ); int LAPACKE_dgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const double* v, int ldv, const double* t, int ldt, double* c, int ldc ); int LAPACKE_dgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const double* v, int ldv, const double* t, int ldt, double* c, int ldc, double* work ); int LAPACKE_dgeqlf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqlf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgeqp3( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau ); int LAPACKE_dgeqp3_work( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau, double* work, int lwork ); int LAPACKE_dgeqpf( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau ); int LAPACKE_dgeqpf_work( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau, double* work ); int LAPACKE_dgeqr2( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqr2_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work ); int LAPACKE_dgeqrf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqrf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgeqrfp( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqrfp_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgeqrt( int matrix_layout, int m, int n, int nb, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt2( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt2_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt3( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt3_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt_work( int matrix_layout, int m, int n, int nb, double* a, int lda, double* t, int ldt, double* work ); int LAPACKE_dgerfs( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dgerfs_work( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgerqf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgerqf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgesdd( int matrix_layout, char jobz, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt ); int LAPACKE_dgesdd_work( int matrix_layout, char jobz, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt, double* work, int lwork, int* iwork ); int LAPACKE_dgesv( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dgesv_work( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt, double* superb ); int LAPACKE_dgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt, double* work, int lwork ); int LAPACKE_dgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, double* a, int lda, double vl, double vu, int il, int iu, int *ns, double* s, double* u, int ldu, double* vt, int ldvt, int* superb ); int LAPACKE_dgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, double* a, int lda, double vl, double vu, int il, int iu, int *ns, double* s, double* u, int ldu, double* vt, int ldvt, double* work, int lwork, int* iwork ); int LAPACKE_dgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, double* a, int lda, double* sva, int mv, double* v, int ldv, double* stat ); int LAPACKE_dgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, double* a, int lda, double* sva, int mv, double* v, int ldv, double* work, int lwork ); int LAPACKE_dgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_dgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgetf2( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetf2_work( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf2( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf2_work( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf_work( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetri( int matrix_layout, int n, double* a, int lda, const int* ipiv ); int LAPACKE_dgetri_work( int matrix_layout, int n, double* a, int lda, const int* ipiv, double* work, int lwork ); int LAPACKE_dgetrs( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dgetrs_work( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, double* v, int ldv ); int LAPACKE_dggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, double* v, int ldv ); int LAPACKE_dggbal( int matrix_layout, char job, int n, double* a, int lda, double* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale ); int LAPACKE_dggbal_work( int matrix_layout, char job, int n, double* a, int lda, double* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work ); int LAPACKE_dgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr ); int LAPACKE_dgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr ); int LAPACKE_dgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* work, int lwork, int* bwork ); int LAPACKE_dgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* work, int lwork, int* bwork ); int LAPACKE_dggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, char sense, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* rconde, double* rcondv ); int LAPACKE_dggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, char sense, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* rconde, double* rcondv, double* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_dggev( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr ); int LAPACKE_dggev3( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr ); int LAPACKE_dggev3_work( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, double* work, int lwork ); int LAPACKE_dggev_work( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, double* work, int lwork ); int LAPACKE_dggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv ); int LAPACKE_dggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, int lwork, int* iwork, int* bwork ); int LAPACKE_dggglm( int matrix_layout, int n, int m, int p, double* a, int lda, double* b, int ldb, double* d, double* x, double* y ); int LAPACKE_dggglm_work( int matrix_layout, int n, int m, int p, double* a, int lda, double* b, int ldb, double* d, double* x, double* y, double* work, int lwork ); int LAPACKE_dgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz ); int LAPACKE_dgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz, double* work, int lwork ); int LAPACKE_dgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz ); int LAPACKE_dgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz ); int LAPACKE_dgglse( int matrix_layout, int m, int n, int p, double* a, int lda, double* b, int ldb, double* c, double* d, double* x ); int LAPACKE_dgglse_work( int matrix_layout, int m, int n, int p, double* a, int lda, double* b, int ldb, double* c, double* d, double* x, double* work, int lwork ); int LAPACKE_dggqrf( int matrix_layout, int n, int m, int p, double* a, int lda, double* taua, double* b, int ldb, double* taub ); int LAPACKE_dggqrf_work( int matrix_layout, int n, int m, int p, double* a, int lda, double* taua, double* b, int ldb, double* taub, double* work, int lwork ); int LAPACKE_dggrqf( int matrix_layout, int m, int p, int n, double* a, int lda, double* taua, double* b, int ldb, double* taub ); int LAPACKE_dggrqf_work( int matrix_layout, int m, int p, int n, double* a, int lda, double* taua, double* b, int ldb, double* taub, double* work, int lwork ); int LAPACKE_dggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork ); int LAPACKE_dggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork ); int LAPACKE_dggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, double* work, int lwork, int* iwork ); int LAPACKE_dggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, double* work, int* iwork ); int LAPACKE_dggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq ); int LAPACKE_dggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq ); int LAPACKE_dggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork, double* tau, double* work, int lwork ); int LAPACKE_dggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork, double* tau, double* work ); int LAPACKE_dgtcon( char norm, int n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dgtcon_work( char norm, int n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dgtrfs( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgtsv( int matrix_layout, int n, int nrhs, double* dl, double* d, double* du, double* b, int ldb ); int LAPACKE_dgtsv_work( int matrix_layout, int n, int nrhs, double* dl, double* d, double* du, double* b, int ldb ); int LAPACKE_dgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgttrf( int n, double* dl, double* d, double* du, double* du2, int* ipiv ); int LAPACKE_dgttrf_work( int n, double* dl, double* d, double* du, double* du2, int* ipiv ); int LAPACKE_dgttrs( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, int ldb ); int LAPACKE_dgttrs_work( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, int ldb ); int LAPACKE_dhgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, double* h, int ldh, double* t, int ldt, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz ); int LAPACKE_dhgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, double* h, int ldh, double* t, int ldt, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz, double* work, int lwork ); int LAPACKE_dhsein( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const double* h, int ldh, double* wr, const double* wi, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_dhsein_work( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const double* h, int ldh, double* wr, const double* wi, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, double* work, int* ifaill, int* ifailr ); int LAPACKE_dhseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, double* h, int ldh, double* wr, double* wi, double* z, int ldz ); int LAPACKE_dhseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, double* h, int ldh, double* wr, double* wi, double* z, int ldz, double* work, int lwork ); int LAPACKE_dlacn2( int n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); int LAPACKE_dlacn2_work( int n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); int LAPACKE_dlacpy( int matrix_layout, char uplo, int m, int n, const double* a, int lda, double* b, int ldb ); int LAPACKE_dlacpy_work( int matrix_layout, char uplo, int m, int n, const double* a, int lda, double* b, int ldb ); int LAPACKE_dlag2s( int matrix_layout, int m, int n, const double* a, int lda, float* sa, int ldsa ); int LAPACKE_dlag2s_work( int matrix_layout, int m, int n, const double* a, int lda, float* sa, int ldsa ); int LAPACKE_dlagge( int matrix_layout, int m, int n, int kl, int ku, const double* d, double* a, int lda, int* iseed ); int LAPACKE_dlagge_work( int matrix_layout, int m, int n, int kl, int ku, const double* d, double* a, int lda, int* iseed, double* work ); int LAPACKE_dlagsy( int matrix_layout, int n, int k, const double* d, double* a, int lda, int* iseed ); int LAPACKE_dlagsy_work( int matrix_layout, int n, int k, const double* d, double* a, int lda, int* iseed, double* work ); int LAPACKE_dlapmr( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlapmr_work( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlapmt( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlapmt_work( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const double* v, int ldv, const double* t, int ldt, double* c, int ldc ); int LAPACKE_dlarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const double* v, int ldv, const double* t, int ldt, double* c, int ldc, double* work, int ldwork ); int LAPACKE_dlarfg( int n, double* alpha, double* x, int incx, double* tau ); int LAPACKE_dlarfg_work( int n, double* alpha, double* x, int incx, double* tau ); int LAPACKE_dlarft( int matrix_layout, char direct, char storev, int n, int k, const double* v, int ldv, const double* tau, double* t, int ldt ); int LAPACKE_dlarft_work( int matrix_layout, char direct, char storev, int n, int k, const double* v, int ldv, const double* tau, double* t, int ldt ); int LAPACKE_dlarfx( int matrix_layout, char side, int m, int n, const double* v, double tau, double* c, int ldc, double* work ); int LAPACKE_dlarfx_work( int matrix_layout, char side, int m, int n, const double* v, double tau, double* c, int ldc, double* work ); int LAPACKE_dlarnv( int idist, int* iseed, int n, double* x ); int LAPACKE_dlarnv_work( int idist, int* iseed, int n, double* x ); int LAPACKE_dlartgp( double f, double g, double* cs, double* sn, double* r ); int LAPACKE_dlartgp_work( double f, double g, double* cs, double* sn, double* r ); int LAPACKE_dlartgs( double x, double y, double sigma, double* cs, double* sn ); int LAPACKE_dlartgs_work( double x, double y, double sigma, double* cs, double* sn ); int LAPACKE_dlascl( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, double* a, int lda ); int LAPACKE_dlascl_work( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, double* a, int lda ); int LAPACKE_dlaset( int matrix_layout, char uplo, int m, int n, double alpha, double beta, double* a, int lda ); int LAPACKE_dlaset_work( int matrix_layout, char uplo, int m, int n, double alpha, double beta, double* a, int lda ); int LAPACKE_dlasrt( char id, int n, double* d ); int LAPACKE_dlasrt_work( char id, int n, double* d ); int LAPACKE_dlaswp( int matrix_layout, int n, double* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_dlaswp_work( int matrix_layout, int n, double* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_dlatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, double* a, int lda ); int LAPACKE_dlatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, double* a, int lda, double* work ); int LAPACKE_dlauum( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dlauum_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dopgtr( int matrix_layout, char uplo, int n, const double* ap, const double* tau, double* q, int ldq ); int LAPACKE_dopgtr_work( int matrix_layout, char uplo, int n, const double* ap, const double* tau, double* q, int ldq, double* work ); int LAPACKE_dopmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* ap, const double* tau, double* c, int ldc ); int LAPACKE_dopmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* ap, const double* tau, double* c, int ldc, double* work ); int LAPACKE_dorbdb( int matrix_layout, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2 ); int LAPACKE_dorbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, int lwork ); int LAPACKE_dorcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t ); int LAPACKE_dorcsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, double* x11, int ldx11, double* x21, int ldx21, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t ); int LAPACKE_dorcsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, double* x11, int ldx11, double* x21, int ldx21, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* work, int lwork, int* iwork ); int LAPACKE_dorcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t, double* work, int lwork, int* iwork ); int LAPACKE_dorgbr( int matrix_layout, char vect, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgbr_work( int matrix_layout, char vect, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorghr( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, const double* tau ); int LAPACKE_dorghr_work( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorglq( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorglq_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgql( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgql_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgqr( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgqr_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgrq( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgrq_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgtr( int matrix_layout, char uplo, int n, double* a, int lda, const double* tau ); int LAPACKE_dorgtr_work( int matrix_layout, char uplo, int n, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dormbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormlq( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormql( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormql_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormqr( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormrq( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dpbcon( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double anorm, double* rcond ); int LAPACKE_dpbcon_work( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dpbequ( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_dpbequ_work( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_dpbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dpbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dpbstf( int matrix_layout, char uplo, int n, int kb, double* bb, int ldbb ); int LAPACKE_dpbstf_work( int matrix_layout, char uplo, int n, int kb, double* bb, int ldbb ); int LAPACKE_dpbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* afb, int ldafb, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dpbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* afb, int ldafb, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dpbtrf( int matrix_layout, char uplo, int n, int kd, double* ab, int ldab ); int LAPACKE_dpbtrf_work( int matrix_layout, char uplo, int n, int kd, double* ab, int ldab ); int LAPACKE_dpbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpftrf( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftrf_work( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftri( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftri_work( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const double* a, double* b, int ldb ); int LAPACKE_dpftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const double* a, double* b, int ldb ); int LAPACKE_dpocon( int matrix_layout, char uplo, int n, const double* a, int lda, double anorm, double* rcond ); int LAPACKE_dpocon_work( int matrix_layout, char uplo, int n, const double* a, int lda, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dpoequ( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dpoequ_work( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dpoequb( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dpoequb_work( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dporfs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dporfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dposv( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dposv_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dpotrf( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrf2( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrf2_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrf_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotri( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotri_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dpotrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dppcon( int matrix_layout, char uplo, int n, const double* ap, double anorm, double* rcond ); int LAPACKE_dppcon_work( int matrix_layout, char uplo, int n, const double* ap, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dppequ( int matrix_layout, char uplo, int n, const double* ap, double* s, double* scond, double* amax ); int LAPACKE_dppequ_work( int matrix_layout, char uplo, int n, const double* ap, double* s, double* scond, double* amax ); int LAPACKE_dpprfs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dpprfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dppsv( int matrix_layout, char uplo, int n, int nrhs, double* ap, double* b, int ldb ); int LAPACKE_dppsv_work( int matrix_layout, char uplo, int n, int nrhs, double* ap, double* b, int ldb ); int LAPACKE_dppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* ap, double* afp, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* ap, double* afp, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dpptrf( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptrf_work( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptri( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptri_work( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptrs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dpptrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dpstrf( int matrix_layout, char uplo, int n, double* a, int lda, int* piv, int* rank, double tol ); int LAPACKE_dpstrf_work( int matrix_layout, char uplo, int n, double* a, int lda, int* piv, int* rank, double tol, double* work ); int LAPACKE_dptcon( int n, const double* d, const double* e, double anorm, double* rcond ); int LAPACKE_dptcon_work( int n, const double* d, const double* e, double anorm, double* rcond, double* work ); int LAPACKE_dpteqr( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dpteqr_work( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz, double* work ); int LAPACKE_dptrfs( int matrix_layout, int n, int nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dptrfs_work( int matrix_layout, int n, int nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work ); int LAPACKE_dptsv( int matrix_layout, int n, int nrhs, double* d, double* e, double* b, int ldb ); int LAPACKE_dptsv_work( int matrix_layout, int n, int nrhs, double* d, double* e, double* b, int ldb ); int LAPACKE_dptsvx( int matrix_layout, char fact, int n, int nrhs, const double* d, const double* e, double* df, double* ef, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dptsvx_work( int matrix_layout, char fact, int n, int nrhs, const double* d, const double* e, double* df, double* ef, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work ); int LAPACKE_dpttrf( int n, double* d, double* e ); int LAPACKE_dpttrf_work( int n, double* d, double* e ); int LAPACKE_dpttrs( int matrix_layout, int n, int nrhs, const double* d, const double* e, double* b, int ldb ); int LAPACKE_dpttrs_work( int matrix_layout, int n, int nrhs, const double* d, const double* e, double* b, int ldb ); int LAPACKE_dsbev( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work ); int LAPACKE_dsbevd( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, double* ab, int ldab, const double* bb, int ldbb, double* x, int ldx ); int LAPACKE_dsbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, double* ab, int ldab, const double* bb, int ldbb, double* x, int ldx, double* work ); int LAPACKE_dsbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz ); int LAPACKE_dsbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz, double* work ); int LAPACKE_dsbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz ); int LAPACKE_dsbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsbtrd( int matrix_layout, char vect, char uplo, int n, int kd, double* ab, int ldab, double* d, double* e, double* q, int ldq ); int LAPACKE_dsbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, double* ab, int ldab, double* d, double* e, double* q, int ldq, double* work ); int LAPACKE_dsfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const double* a, int lda, double beta, double* c ); int LAPACKE_dsfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const double* a, int lda, double beta, double* c ); int LAPACKE_dsgesv( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* x, int ldx, int* iter ); int LAPACKE_dsgesv_work( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* x, int ldx, double* work, float* swork, int* iter ); int LAPACKE_dspcon( int matrix_layout, char uplo, int n, const double* ap, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dspcon_work( int matrix_layout, char uplo, int n, const double* ap, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dspev( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz ); int LAPACKE_dspev_work( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz, double* work ); int LAPACKE_dspevd( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz ); int LAPACKE_dspevd_work( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dspevx( int matrix_layout, char jobz, char range, char uplo, int n, double* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dspevx_work( int matrix_layout, char jobz, char range, char uplo, int n, double* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dspgst( int matrix_layout, int itype, char uplo, int n, double* ap, const double* bp ); int LAPACKE_dspgst_work( int matrix_layout, int itype, char uplo, int n, double* ap, const double* bp ); int LAPACKE_dspgv( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz ); int LAPACKE_dspgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz, double* work ); int LAPACKE_dspgvd( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz ); int LAPACKE_dspgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dspgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* ap, double* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dspgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* ap, double* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsposv( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb, double* x, int ldx, int* iter ); int LAPACKE_dsposv_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb, double* x, int ldx, double* work, float* swork, int* iter ); int LAPACKE_dsprfs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dsprfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dspsv( int matrix_layout, char uplo, int n, int nrhs, double* ap, int* ipiv, double* b, int ldb ); int LAPACKE_dspsv_work( int matrix_layout, char uplo, int n, int nrhs, double* ap, int* ipiv, double* b, int ldb ); int LAPACKE_dspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* ap, double* afp, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* ap, double* afp, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dsptrd( int matrix_layout, char uplo, int n, double* ap, double* d, double* e, double* tau ); int LAPACKE_dsptrd_work( int matrix_layout, char uplo, int n, double* ap, double* d, double* e, double* tau ); int LAPACKE_dsptrf( int matrix_layout, char uplo, int n, double* ap, int* ipiv ); int LAPACKE_dsptrf_work( int matrix_layout, char uplo, int n, double* ap, int* ipiv ); int LAPACKE_dsptri( int matrix_layout, char uplo, int n, double* ap, const int* ipiv ); int LAPACKE_dsptri_work( int matrix_layout, char uplo, int n, double* ap, const int* ipiv, double* work ); int LAPACKE_dsptrs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const int* ipiv, double* b, int ldb ); int LAPACKE_dsptrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const int* ipiv, double* b, int ldb ); int LAPACKE_dstebz( char range, char order, int n, double vl, double vu, int il, int iu, double abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit ); int LAPACKE_dstebz_work( char range, char order, int n, double vl, double vu, int il, int iu, double abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork ); int LAPACKE_dstedc( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dstedc_work( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstegr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dstegr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstein( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, double* z, int ldz, int* ifailv ); int LAPACKE_dstein_work( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, double* z, int ldz, double* work, int* iwork, int* ifailv ); int LAPACKE_dstemr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, double* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_dstemr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, double* z, int ldz, int nzc, int* isuppz, int* tryrac, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsteqr( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dsteqr_work( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz, double* work ); int LAPACKE_dsterf( int n, double* d, double* e ); int LAPACKE_dsterf_work( int n, double* d, double* e ); int LAPACKE_dstev( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dstev_work( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz, double* work ); int LAPACKE_dstevd( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dstevd_work( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstevr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dstevr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstevx( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dstevx_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsycon( int matrix_layout, char uplo, int n, const double* a, int lda, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dsycon_work( int matrix_layout, char uplo, int n, const double* a, int lda, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dsyconv( int matrix_layout, char uplo, char way, int n, double* a, int lda, const int* ipiv, double* e ); int LAPACKE_dsyconv_work( int matrix_layout, char uplo, char way, int n, double* a, int lda, const int* ipiv, double* e ); int LAPACKE_dsyequb( int matrix_layout, char uplo, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dsyequb_work( int matrix_layout, char uplo, int n, const double* a, int lda, double* s, double* scond, double* amax, double* work ); int LAPACKE_dsyev( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyev_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork ); int LAPACKE_dsyevd( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyevd_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevr( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dsyevr_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevx( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsyevx_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsygst( int matrix_layout, int itype, char uplo, int n, double* a, int lda, const double* b, int ldb ); int LAPACKE_dsygst_work( int matrix_layout, int itype, char uplo, int n, double* a, int lda, const double* b, int ldb ); int LAPACKE_dsygv( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w ); int LAPACKE_dsygv_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w, double* work, int lwork ); int LAPACKE_dsygvd( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w ); int LAPACKE_dsygvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsygvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* a, int lda, double* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsygvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* a, int lda, double* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsyrfs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dsyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dsyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dsyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dsysv( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_rook( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsysv_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* a, int lda, double* af, int ldaf, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dsysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* a, int lda, double* af, int ldaf, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int lwork, int* iwork ); int LAPACKE_dsysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dsysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dsyswapr( int matrix_layout, char uplo, int n, double* a, int lda, int i1, int i2 ); int LAPACKE_dsyswapr_work( int matrix_layout, char uplo, int n, double* a, int lda, int i1, int i2 ); int LAPACKE_dsytrd( int matrix_layout, char uplo, int n, double* a, int lda, double* d, double* e, double* tau ); int LAPACKE_dsytrd_work( int matrix_layout, char uplo, int n, double* a, int lda, double* d, double* e, double* tau, double* work, int lwork ); int LAPACKE_dsytrf( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv ); int LAPACKE_dsytrf_rook( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv ); int LAPACKE_dsytrf_rook_work( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv, double* work, int lwork ); int LAPACKE_dsytrf_work( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv, double* work, int lwork ); int LAPACKE_dsytri( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv ); int LAPACKE_dsytri2( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv ); int LAPACKE_dsytri2_work( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, double* work, int lwork ); int LAPACKE_dsytri2x( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, int nb ); int LAPACKE_dsytri2x_work( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, double* work, int nb ); int LAPACKE_dsytri_work( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, double* work ); int LAPACKE_dsytrs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs2( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb, double* work ); int LAPACKE_dsytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dtbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const double* ab, int ldab, double* rcond ); int LAPACKE_dtbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const double* ab, int ldab, double* rcond, double* work, int* iwork ); int LAPACKE_dtbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dtbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dtbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dtbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dtfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, double alpha, const double* a, double* b, int ldb ); int LAPACKE_dtfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, double alpha, const double* a, double* b, int ldb ); int LAPACKE_dtftri( int matrix_layout, char transr, char uplo, char diag, int n, double* a ); int LAPACKE_dtftri_work( int matrix_layout, char transr, char uplo, char diag, int n, double* a ); int LAPACKE_dtfttp( int matrix_layout, char transr, char uplo, int n, const double* arf, double* ap ); int LAPACKE_dtfttp_work( int matrix_layout, char transr, char uplo, int n, const double* arf, double* ap ); int LAPACKE_dtfttr( int matrix_layout, char transr, char uplo, int n, const double* arf, double* a, int lda ); int LAPACKE_dtfttr_work( int matrix_layout, char transr, char uplo, int n, const double* arf, double* a, int lda ); int LAPACKE_dtgevc( int matrix_layout, char side, char howmny, const int* select, int n, const double* s, int lds, const double* p, int ldp, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m ); int LAPACKE_dtgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const double* s, int lds, const double* p, int ldp, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, double* work ); int LAPACKE_dtgexc( int matrix_layout, int wantq, int wantz, int n, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz, int* ifst, int* ilst ); int LAPACKE_dtgexc_work( int matrix_layout, int wantq, int wantz, int n, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz, int* ifst, int* ilst, double* work, int lwork ); int LAPACKE_dtgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz, int* m, double* pl, double* pr, double* dif ); int LAPACKE_dtgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz, int* m, double* pl, double* pr, double* dif, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dtgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, double* a, int lda, double* b, int ldb, double tola, double tolb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* ncycle ); int LAPACKE_dtgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, double* a, int lda, double* b, int ldb, double tola, double tolb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, double* work, int* ncycle ); int LAPACKE_dtgsna( int matrix_layout, char job, char howmny, const int* select, int n, const double* a, int lda, const double* b, int ldb, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* dif, int mm, int* m ); int LAPACKE_dtgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const double* a, int lda, const double* b, int ldb, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* dif, int mm, int* m, double* work, int lwork, int* iwork ); int LAPACKE_dtgsyl( int matrix_layout, char trans, int ijob, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, const double* d, int ldd, const double* e, int lde, double* f, int ldf, double* scale, double* dif ); int LAPACKE_dtgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, const double* d, int ldd, const double* e, int lde, double* f, int ldf, double* scale, double* dif, double* work, int lwork, int* iwork ); int LAPACKE_dtpcon( int matrix_layout, char norm, char uplo, char diag, int n, const double* ap, double* rcond ); int LAPACKE_dtpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const double* ap, double* rcond, double* work, int* iwork ); int LAPACKE_dtpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb ); int LAPACKE_dtpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb, double* work ); int LAPACKE_dtpqrt( int matrix_layout, int m, int n, int l, int nb, double* a, int lda, double* b, int ldb, double* t, int ldt ); int LAPACKE_dtpqrt2( int matrix_layout, int m, int n, int l, double* a, int lda, double* b, int ldb, double* t, int ldt ); int LAPACKE_dtpqrt2_work( int matrix_layout, int m, int n, int l, double* a, int lda, double* b, int ldb, double* t, int ldt ); int LAPACKE_dtpqrt_work( int matrix_layout, int m, int n, int l, int nb, double* a, int lda, double* b, int ldb, double* t, int ldt, double* work ); int LAPACKE_dtprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb ); int LAPACKE_dtprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb, double* work, int ldwork ); int LAPACKE_dtprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dtprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dtptri( int matrix_layout, char uplo, char diag, int n, double* ap ); int LAPACKE_dtptri_work( int matrix_layout, char uplo, char diag, int n, double* ap ); int LAPACKE_dtptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dtptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dtpttf( int matrix_layout, char transr, char uplo, int n, const double* ap, double* arf ); int LAPACKE_dtpttf_work( int matrix_layout, char transr, char uplo, int n, const double* ap, double* arf ); int LAPACKE_dtpttr( int matrix_layout, char uplo, int n, const double* ap, double* a, int lda ); int LAPACKE_dtpttr_work( int matrix_layout, char uplo, int n, const double* ap, double* a, int lda ); int LAPACKE_dtrcon( int matrix_layout, char norm, char uplo, char diag, int n, const double* a, int lda, double* rcond ); int LAPACKE_dtrcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const double* a, int lda, double* rcond, double* work, int* iwork ); int LAPACKE_dtrevc( int matrix_layout, char side, char howmny, int* select, int n, const double* t, int ldt, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m ); int LAPACKE_dtrevc_work( int matrix_layout, char side, char howmny, int* select, int n, const double* t, int ldt, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, double* work ); int LAPACKE_dtrexc( int matrix_layout, char compq, int n, double* t, int ldt, double* q, int ldq, int* ifst, int* ilst ); int LAPACKE_dtrexc_work( int matrix_layout, char compq, int n, double* t, int ldt, double* q, int ldq, int* ifst, int* ilst, double* work ); int LAPACKE_dtrrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dtrrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dtrsen( int matrix_layout, char job, char compq, const int* select, int n, double* t, int ldt, double* q, int ldq, double* wr, double* wi, int* m, double* s, double* sep ); int LAPACKE_dtrsen_work( int matrix_layout, char job, char compq, const int* select, int n, double* t, int ldt, double* q, int ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dtrsna( int matrix_layout, char job, char howmny, const int* select, int n, const double* t, int ldt, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* sep, int mm, int* m ); int LAPACKE_dtrsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const double* t, int ldt, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* sep, int mm, int* m, double* work, int ldwork, int* iwork ); int LAPACKE_dtrsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, double* scale ); int LAPACKE_dtrsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, double* scale ); int LAPACKE_dtrtri( int matrix_layout, char uplo, char diag, int n, double* a, int lda ); int LAPACKE_dtrtri_work( int matrix_layout, char uplo, char diag, int n, double* a, int lda ); int LAPACKE_dtrtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dtrtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dtrttf( int matrix_layout, char transr, char uplo, int n, const double* a, int lda, double* arf ); int LAPACKE_dtrttf_work( int matrix_layout, char transr, char uplo, int n, const double* a, int lda, double* arf ); int LAPACKE_dtrttp( int matrix_layout, char uplo, int n, const double* a, int lda, double* ap ); int LAPACKE_dtrttp_work( int matrix_layout, char uplo, int n, const double* a, int lda, double* ap ); int LAPACKE_dtzrzf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dtzrzf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_mkl_cgetrfnpi( int matrix_layout, int m, int n, int nfact, MKL_Complex8* a, int lda ); int LAPACKE_mkl_cgetrfnpi_work( int matrix_layout, int m, int n, int nfact, MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctppack( int matrix_layout, char uplo, char trans, int n, MKL_Complex8* ap, int i, int j, int rows, int cols, const MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctppack_work( int matrix_layout, char uplo, char trans, int n, MKL_Complex8* ap, int i, int j, int rows, int cols, const MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctpunpack( int matrix_layout, char uplo, char trans, int n, const MKL_Complex8* ap, int i, int j, int rows, int cols, MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctpunpack_work( int matrix_layout, char uplo, char trans, int n, const MKL_Complex8* ap, int i, int j, int rows, int cols, MKL_Complex8* a, int lda ); int LAPACKE_mkl_dgetrfnpi( int matrix_layout, int m, int n, int nfact, double* a, int lda ); int LAPACKE_mkl_dgetrfnpi_work( int matrix_layout, int m, int n, int nfact, double* a, int lda ); int LAPACKE_mkl_dtppack( int matrix_layout, char uplo, char trans, int n, double* ap, int i, int j, int rows, int cols, const double* a, int lda ); int LAPACKE_mkl_dtppack_work( int matrix_layout, char uplo, char trans, int n, double* ap, int i, int j, int rows, int cols, const double* a, int lda ); int LAPACKE_mkl_dtpunpack( int matrix_layout, char uplo, char trans, int n, const double* ap, int i, int j, int rows, int cols, double* a, int lda ); int LAPACKE_mkl_dtpunpack_work( int matrix_layout, char uplo, char trans, int n, const double* ap, int i, int j, int rows, int cols, double* a, int lda ); int LAPACKE_mkl_sgetrfnpi( int matrix_layout, int m, int n, int nfact, float* a, int lda); int LAPACKE_mkl_sgetrfnpi_work( int matrix_layout, int m, int n, int nfact, float* a, int lda ); int LAPACKE_mkl_stppack( int matrix_layout, char uplo, char trans, int n, float* ap, int i, int j, int rows, int cols, const float* a, int lda ); int LAPACKE_mkl_stppack_work( int matrix_layout, char uplo, char trans, int n, float* ap, int i, int j, int rows, int cols, const float* a, int lda ); int LAPACKE_mkl_stpunpack( int matrix_layout, char uplo, char trans, int n, const float* ap, int i, int j, int rows, int cols, float* a, int lda ); int LAPACKE_mkl_stpunpack_work( int matrix_layout, char uplo, char trans, int n, const float* ap, int i, int j, int rows, int cols, float* a, int lda ); int LAPACKE_mkl_zgetrfnpi( int matrix_layout, int m, int n, int nfact, MKL_Complex16* a, int lda ); int LAPACKE_mkl_zgetrfnpi_work( int matrix_layout, int m, int n, int nfact, MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztppack( int matrix_layout, char uplo, char trans, int n, MKL_Complex16* ap, int i, int j, int rows, int cols, const MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztppack_work( int matrix_layout, char uplo, char trans, int n, MKL_Complex16* ap, int i, int j, int rows, int cols, const MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztpunpack( int matrix_layout, char uplo, char trans, int n, const MKL_Complex16* ap, int i, int j, int rows, int cols, MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztpunpack_work( int matrix_layout, char uplo, char trans, int n, const MKL_Complex16* ap, int i, int j, int rows, int cols, MKL_Complex16* a, int lda ); int LAPACKE_sbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e ); int LAPACKE_sbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* work, int lwork ); int LAPACKE_sbdsdc( int matrix_layout, char uplo, char compq, int n, float* d, float* e, float* u, int ldu, float* vt, int ldvt, float* q, int* iq ); int LAPACKE_sbdsdc_work( int matrix_layout, char uplo, char compq, int n, float* d, float* e, float* u, int ldu, float* vt, int ldvt, float* q, int* iq, float* work, int* iwork ); int LAPACKE_sbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, float* vt, int ldvt, float* u, int ldu, float* c, int ldc ); int LAPACKE_sbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, float* vt, int ldvt, float* u, int ldu, float* c, int ldc, float* work ); int LAPACKE_sbdsvdx( int matrix_layout, char uplo, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* ns, float* s, float* z, int ldz, int* superb ); int LAPACKE_sbdsvdx_work( int matrix_layout, char uplo, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* ns, float* s, float* z, int ldz, float* work, int* iwork ); int LAPACKE_sdisna( char job, int m, int n, const float* d, float* sep ); int LAPACKE_sdisna_work( char job, int m, int n, const float* d, float* sep ); int LAPACKE_sgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, float* ab, int ldab, float* d, float* e, float* q, int ldq, float* pt, int ldpt, float* c, int ldc ); int LAPACKE_sgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, float* ab, int ldab, float* d, float* e, float* q, int ldq, float* pt, int ldpt, float* c, int ldc, float* work ); int LAPACKE_sgbcon( int matrix_layout, char norm, int n, int kl, int ku, const float* ab, int ldab, const int* ipiv, float anorm, float* rcond ); int LAPACKE_sgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const float* ab, int ldab, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sgbequ( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbequb( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, float* ab, int ldab, int* ipiv, float* b, int ldb ); int LAPACKE_sgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, float* ab, int ldab, int* ipiv, float* b, int ldb ); int LAPACKE_sgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_sgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgbtrf( int matrix_layout, int m, int n, int kl, int ku, float* ab, int ldab, int* ipiv ); int LAPACKE_sgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, float* ab, int ldab, int* ipiv ); int LAPACKE_sgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const int* ipiv, float* b, int ldb ); int LAPACKE_sgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const int* ipiv, float* b, int ldb ); int LAPACKE_sgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, float* v, int ldv ); int LAPACKE_sgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, float* v, int ldv ); int LAPACKE_sgebal( int matrix_layout, char job, int n, float* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_sgebal_work( int matrix_layout, char job, int n, float* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_sgebrd( int matrix_layout, int m, int n, float* a, int lda, float* d, float* e, float* tauq, float* taup ); int LAPACKE_sgebrd_work( int matrix_layout, int m, int n, float* a, int lda, float* d, float* e, float* tauq, float* taup, float* work, int lwork ); int LAPACKE_sgecon( int matrix_layout, char norm, int n, const float* a, int lda, float anorm, float* rcond ); int LAPACKE_sgecon_work( int matrix_layout, char norm, int n, const float* a, int lda, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sgeequ( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgeequ_work( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgeequb( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgeequb_work( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgees( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs ); int LAPACKE_sgees_work( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs, float* work, int lwork, int* bwork ); int LAPACKE_sgeesx( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, char sense, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs, float* rconde, float* rcondv ); int LAPACKE_sgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, char sense, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs, float* rconde, float* rcondv, float* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_sgeev( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr ); int LAPACKE_sgeev_work( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr, float* work, int lwork ); int LAPACKE_sgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv ); int LAPACKE_sgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, int lwork, int* iwork ); int LAPACKE_sgehrd( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, float* tau ); int LAPACKE_sgehrd_work( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, float* a, int lda, float* sva, float* u, int ldu, float* v, int ldv, float* stat, int* istat ); int LAPACKE_sgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, float* a, int lda, float* sva, float* u, int ldu, float* v, int ldv, float* work, int lwork, int* iwork ); int LAPACKE_sgelq2( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgelq2_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work ); int LAPACKE_sgelqf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgelqf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgels( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sgels_work( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* work, int lwork ); int LAPACKE_sgelsd( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_sgelsd_work( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank, float* work, int lwork, int* iwork ); int LAPACKE_sgelss( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_sgelss_work( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank, float* work, int lwork ); int LAPACKE_sgelsy( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, int* jpvt, float rcond, int* rank ); int LAPACKE_sgelsy_work( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, int* jpvt, float rcond, int* rank, float* work, int lwork ); int LAPACKE_sgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const float* v, int ldv, const float* t, int ldt, float* c, int ldc ); int LAPACKE_sgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const float* v, int ldv, const float* t, int ldt, float* c, int ldc, float* work ); int LAPACKE_sgeqlf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqlf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgeqp3( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau ); int LAPACKE_sgeqp3_work( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau, float* work, int lwork ); int LAPACKE_sgeqpf( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau ); int LAPACKE_sgeqpf_work( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau, float* work ); int LAPACKE_sgeqr2( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqr2_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work ); int LAPACKE_sgeqrf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqrf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgeqrfp( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqrfp_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgeqrt( int matrix_layout, int m, int n, int nb, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt2( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt2_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt3( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt3_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt_work( int matrix_layout, int m, int n, int nb, float* a, int lda, float* t, int ldt, float* work ); int LAPACKE_sgerfs( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sgerfs_work( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgerqf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgerqf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgesdd( int matrix_layout, char jobz, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt ); int LAPACKE_sgesdd_work( int matrix_layout, char jobz, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt, float* work, int lwork, int* iwork ); int LAPACKE_sgesv( int matrix_layout, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_sgesv_work( int matrix_layout, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_sgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt, float* superb ); int LAPACKE_sgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt, float* work, int lwork ); int LAPACKE_sgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, float* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, float* u, int ldu, float* vt, int ldvt, int* superb ); int LAPACKE_sgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, float* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, float* u, int ldu, float* vt, int ldvt, float* work, int lwork, int* iwork ); int LAPACKE_sgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, float* a, int lda, float* sva, int mv, float* v, int ldv, float* stat ); int LAPACKE_sgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, float* a, int lda, float* sva, int mv, float* v, int ldv, float* work, int lwork ); int LAPACKE_sgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_sgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgetf2( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetf2_work( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf2( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf2_work( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf_work( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetri( int matrix_layout, int n, float* a, int lda, const int* ipiv ); int LAPACKE_sgetri_work( int matrix_layout, int n, float* a, int lda, const int* ipiv, float* work, int lwork ); int LAPACKE_sgetrs( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_sgetrs_work( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_sggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, float* v, int ldv ); int LAPACKE_sggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, float* v, int ldv ); int LAPACKE_sggbal( int matrix_layout, char job, int n, float* a, int lda, float* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale ); int LAPACKE_sggbal_work( int matrix_layout, char job, int n, float* a, int lda, float* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work ); int LAPACKE_sgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr ); int LAPACKE_sgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr ); int LAPACKE_sgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* work, int lwork, int* bwork ); int LAPACKE_sgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* work, int lwork, int* bwork ); int LAPACKE_sggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, char sense, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* rconde, float* rcondv ); int LAPACKE_sggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, char sense, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* rconde, float* rcondv, float* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_sggev( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr ); int LAPACKE_sggev3( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr ); int LAPACKE_sggev3_work( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, float* work, int lwork ); int LAPACKE_sggev_work( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, float* work, int lwork ); int LAPACKE_sggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv ); int LAPACKE_sggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, int lwork, int* iwork, int* bwork ); int LAPACKE_sggglm( int matrix_layout, int n, int m, int p, float* a, int lda, float* b, int ldb, float* d, float* x, float* y ); int LAPACKE_sggglm_work( int matrix_layout, int n, int m, int p, float* a, int lda, float* b, int ldb, float* d, float* x, float* y, float* work, int lwork ); int LAPACKE_sgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz ); int LAPACKE_sgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz, float* work, int lwork ); int LAPACKE_sgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz ); int LAPACKE_sgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz ); int LAPACKE_sgglse( int matrix_layout, int m, int n, int p, float* a, int lda, float* b, int ldb, float* c, float* d, float* x ); int LAPACKE_sgglse_work( int matrix_layout, int m, int n, int p, float* a, int lda, float* b, int ldb, float* c, float* d, float* x, float* work, int lwork ); int LAPACKE_sggqrf( int matrix_layout, int n, int m, int p, float* a, int lda, float* taua, float* b, int ldb, float* taub ); int LAPACKE_sggqrf_work( int matrix_layout, int n, int m, int p, float* a, int lda, float* taua, float* b, int ldb, float* taub, float* work, int lwork ); int LAPACKE_sggrqf( int matrix_layout, int m, int p, int n, float* a, int lda, float* taua, float* b, int ldb, float* taub ); int LAPACKE_sggrqf_work( int matrix_layout, int m, int p, int n, float* a, int lda, float* taua, float* b, int ldb, float* taub, float* work, int lwork ); int LAPACKE_sggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork ); int LAPACKE_sggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork ); int LAPACKE_sggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, float* work, int lwork, int* iwork ); int LAPACKE_sggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, float* work, int* iwork ); int LAPACKE_sggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq ); int LAPACKE_sggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq ); int LAPACKE_sggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork, float* tau, float* work, int lwork ); int LAPACKE_sggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork, float* tau, float* work ); int LAPACKE_sgtcon( char norm, int n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float anorm, float* rcond ); int LAPACKE_sgtcon_work( char norm, int n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sgtrfs( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgtsv( int matrix_layout, int n, int nrhs, float* dl, float* d, float* du, float* b, int ldb ); int LAPACKE_sgtsv_work( int matrix_layout, int n, int nrhs, float* dl, float* d, float* du, float* b, int ldb ); int LAPACKE_sgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgttrf( int n, float* dl, float* d, float* du, float* du2, int* ipiv ); int LAPACKE_sgttrf_work( int n, float* dl, float* d, float* du, float* du2, int* ipiv ); int LAPACKE_sgttrs( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, int ldb ); int LAPACKE_sgttrs_work( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, int ldb ); int LAPACKE_shgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, float* h, int ldh, float* t, int ldt, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz ); int LAPACKE_shgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, float* h, int ldh, float* t, int ldt, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz, float* work, int lwork ); int LAPACKE_shsein( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const float* h, int ldh, float* wr, const float* wi, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_shsein_work( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const float* h, int ldh, float* wr, const float* wi, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, float* work, int* ifaill, int* ifailr ); int LAPACKE_shseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, float* h, int ldh, float* wr, float* wi, float* z, int ldz ); int LAPACKE_shseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, float* h, int ldh, float* wr, float* wi, float* z, int ldz, float* work, int lwork ); int LAPACKE_slacn2( int n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); int LAPACKE_slacn2_work( int n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); int LAPACKE_slacpy( int matrix_layout, char uplo, int m, int n, const float* a, int lda, float* b, int ldb ); int LAPACKE_slacpy_work( int matrix_layout, char uplo, int m, int n, const float* a, int lda, float* b, int ldb ); int LAPACKE_slag2d( int matrix_layout, int m, int n, const float* sa, int ldsa, double* a, int lda ); int LAPACKE_slag2d_work( int matrix_layout, int m, int n, const float* sa, int ldsa, double* a, int lda ); int LAPACKE_slagge( int matrix_layout, int m, int n, int kl, int ku, const float* d, float* a, int lda, int* iseed ); int LAPACKE_slagge_work( int matrix_layout, int m, int n, int kl, int ku, const float* d, float* a, int lda, int* iseed, float* work ); int LAPACKE_slagsy( int matrix_layout, int n, int k, const float* d, float* a, int lda, int* iseed ); int LAPACKE_slagsy_work( int matrix_layout, int n, int k, const float* d, float* a, int lda, int* iseed, float* work ); int LAPACKE_slapmr( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slapmr_work( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slapmt( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slapmt_work( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const float* v, int ldv, const float* t, int ldt, float* c, int ldc ); int LAPACKE_slarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const float* v, int ldv, const float* t, int ldt, float* c, int ldc, float* work, int ldwork ); int LAPACKE_slarfg( int n, float* alpha, float* x, int incx, float* tau ); int LAPACKE_slarfg_work( int n, float* alpha, float* x, int incx, float* tau ); int LAPACKE_slarft( int matrix_layout, char direct, char storev, int n, int k, const float* v, int ldv, const float* tau, float* t, int ldt ); int LAPACKE_slarft_work( int matrix_layout, char direct, char storev, int n, int k, const float* v, int ldv, const float* tau, float* t, int ldt ); int LAPACKE_slarfx( int matrix_layout, char side, int m, int n, const float* v, float tau, float* c, int ldc, float* work ); int LAPACKE_slarfx_work( int matrix_layout, char side, int m, int n, const float* v, float tau, float* c, int ldc, float* work ); int LAPACKE_slarnv( int idist, int* iseed, int n, float* x ); int LAPACKE_slarnv_work( int idist, int* iseed, int n, float* x ); int LAPACKE_slartgp( float f, float g, float* cs, float* sn, float* r ); int LAPACKE_slartgp_work( float f, float g, float* cs, float* sn, float* r ); int LAPACKE_slartgs( float x, float y, float sigma, float* cs, float* sn ); int LAPACKE_slartgs_work( float x, float y, float sigma, float* cs, float* sn ); int LAPACKE_slascl( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, float* a, int lda ); int LAPACKE_slascl_work( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, float* a, int lda ); int LAPACKE_slaset( int matrix_layout, char uplo, int m, int n, float alpha, float beta, float* a, int lda ); int LAPACKE_slaset_work( int matrix_layout, char uplo, int m, int n, float alpha, float beta, float* a, int lda ); int LAPACKE_slasrt( char id, int n, float* d ); int LAPACKE_slasrt_work( char id, int n, float* d ); int LAPACKE_slaswp( int matrix_layout, int n, float* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_slaswp_work( int matrix_layout, int n, float* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_slatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, float* a, int lda ); int LAPACKE_slatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, float* a, int lda, float* work ); int LAPACKE_slauum( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_slauum_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_sopgtr( int matrix_layout, char uplo, int n, const float* ap, const float* tau, float* q, int ldq ); int LAPACKE_sopgtr_work( int matrix_layout, char uplo, int n, const float* ap, const float* tau, float* q, int ldq, float* work ); int LAPACKE_sopmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* ap, const float* tau, float* c, int ldc ); int LAPACKE_sopmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* ap, const float* tau, float* c, int ldc, float* work ); int LAPACKE_sorbdb( int matrix_layout, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2 ); int LAPACKE_sorbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, int lwork ); int LAPACKE_sorcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t ); int LAPACKE_sorcsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, float* x11, int ldx11, float* x21, int ldx21, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t ); int LAPACKE_sorcsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, float* x11, int ldx11, float* x21, int ldx21, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* work, int lwork, int* iwork ); int LAPACKE_sorcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t, float* work, int lwork, int* iwork ); int LAPACKE_sorgbr( int matrix_layout, char vect, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgbr_work( int matrix_layout, char vect, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorghr( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, const float* tau ); int LAPACKE_sorghr_work( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorglq( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorglq_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgql( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgql_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgqr( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgqr_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgrq( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgrq_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgtr( int matrix_layout, char uplo, int n, float* a, int lda, const float* tau ); int LAPACKE_sorgtr_work( int matrix_layout, char uplo, int n, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sormbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormlq( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormql( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormql_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormqr( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormrq( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_spbcon( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float anorm, float* rcond ); int LAPACKE_spbcon_work( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_spbequ( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_spbequ_work( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_spbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_spbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_spbstf( int matrix_layout, char uplo, int n, int kb, float* bb, int ldbb ); int LAPACKE_spbstf_work( int matrix_layout, char uplo, int n, int kb, float* bb, int ldbb ); int LAPACKE_spbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* b, int ldb ); int LAPACKE_spbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* b, int ldb ); int LAPACKE_spbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* afb, int ldafb, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_spbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* afb, int ldafb, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_spbtrf( int matrix_layout, char uplo, int n, int kd, float* ab, int ldab ); int LAPACKE_spbtrf_work( int matrix_layout, char uplo, int n, int kd, float* ab, int ldab ); int LAPACKE_spbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_spbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_spftrf( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftrf_work( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftri( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftri_work( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const float* a, float* b, int ldb ); int LAPACKE_spftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const float* a, float* b, int ldb ); int LAPACKE_spocon( int matrix_layout, char uplo, int n, const float* a, int lda, float anorm, float* rcond ); int LAPACKE_spocon_work( int matrix_layout, char uplo, int n, const float* a, int lda, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_spoequ( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_spoequ_work( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_spoequb( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_spoequb_work( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_sporfs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sporfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sposv( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sposv_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_spotrf( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrf2( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrf2_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrf_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotri( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotri_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_spotrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_sppcon( int matrix_layout, char uplo, int n, const float* ap, float anorm, float* rcond ); int LAPACKE_sppcon_work( int matrix_layout, char uplo, int n, const float* ap, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sppequ( int matrix_layout, char uplo, int n, const float* ap, float* s, float* scond, float* amax ); int LAPACKE_sppequ_work( int matrix_layout, char uplo, int n, const float* ap, float* s, float* scond, float* amax ); int LAPACKE_spprfs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_spprfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sppsv( int matrix_layout, char uplo, int n, int nrhs, float* ap, float* b, int ldb ); int LAPACKE_sppsv_work( int matrix_layout, char uplo, int n, int nrhs, float* ap, float* b, int ldb ); int LAPACKE_sppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* ap, float* afp, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* ap, float* afp, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_spptrf( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptrf_work( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptri( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptri_work( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptrs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_spptrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_spstrf( int matrix_layout, char uplo, int n, float* a, int lda, int* piv, int* rank, float tol ); int LAPACKE_spstrf_work( int matrix_layout, char uplo, int n, float* a, int lda, int* piv, int* rank, float tol, float* work ); int LAPACKE_sptcon( int n, const float* d, const float* e, float anorm, float* rcond ); int LAPACKE_sptcon_work( int n, const float* d, const float* e, float anorm, float* rcond, float* work ); int LAPACKE_spteqr( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_spteqr_work( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz, float* work ); int LAPACKE_sptrfs( int matrix_layout, int n, int nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sptrfs_work( int matrix_layout, int n, int nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work ); int LAPACKE_sptsv( int matrix_layout, int n, int nrhs, float* d, float* e, float* b, int ldb ); int LAPACKE_sptsv_work( int matrix_layout, int n, int nrhs, float* d, float* e, float* b, int ldb ); int LAPACKE_sptsvx( int matrix_layout, char fact, int n, int nrhs, const float* d, const float* e, float* df, float* ef, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sptsvx_work( int matrix_layout, char fact, int n, int nrhs, const float* d, const float* e, float* df, float* ef, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work ); int LAPACKE_spttrf( int n, float* d, float* e ); int LAPACKE_spttrf_work( int n, float* d, float* e ); int LAPACKE_spttrs( int matrix_layout, int n, int nrhs, const float* d, const float* e, float* b, int ldb ); int LAPACKE_spttrs_work( int matrix_layout, int n, int nrhs, const float* d, const float* e, float* b, int ldb ); int LAPACKE_ssbev( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work ); int LAPACKE_ssbevd( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, float* ab, int ldab, const float* bb, int ldbb, float* x, int ldx ); int LAPACKE_ssbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, float* ab, int ldab, const float* bb, int ldbb, float* x, int ldx, float* work ); int LAPACKE_ssbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz ); int LAPACKE_ssbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz, float* work ); int LAPACKE_ssbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz ); int LAPACKE_ssbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssbtrd( int matrix_layout, char vect, char uplo, int n, int kd, float* ab, int ldab, float* d, float* e, float* q, int ldq ); int LAPACKE_ssbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, float* ab, int ldab, float* d, float* e, float* q, int ldq, float* work ); int LAPACKE_ssfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const float* a, int lda, float beta, float* c ); int LAPACKE_ssfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const float* a, int lda, float beta, float* c ); int LAPACKE_sspcon( int matrix_layout, char uplo, int n, const float* ap, const int* ipiv, float anorm, float* rcond ); int LAPACKE_sspcon_work( int matrix_layout, char uplo, int n, const float* ap, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sspev( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz ); int LAPACKE_sspev_work( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz, float* work ); int LAPACKE_sspevd( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz ); int LAPACKE_sspevd_work( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sspevx( int matrix_layout, char jobz, char range, char uplo, int n, float* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_sspevx_work( int matrix_layout, char jobz, char range, char uplo, int n, float* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_sspgst( int matrix_layout, int itype, char uplo, int n, float* ap, const float* bp ); int LAPACKE_sspgst_work( int matrix_layout, int itype, char uplo, int n, float* ap, const float* bp ); int LAPACKE_sspgv( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz ); int LAPACKE_sspgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz, float* work ); int LAPACKE_sspgvd( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz ); int LAPACKE_sspgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sspgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* ap, float* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_sspgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* ap, float* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssprfs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_ssprfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sspsv( int matrix_layout, char uplo, int n, int nrhs, float* ap, int* ipiv, float* b, int ldb ); int LAPACKE_sspsv_work( int matrix_layout, char uplo, int n, int nrhs, float* ap, int* ipiv, float* b, int ldb ); int LAPACKE_sspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* ap, float* afp, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* ap, float* afp, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_ssptrd( int matrix_layout, char uplo, int n, float* ap, float* d, float* e, float* tau ); int LAPACKE_ssptrd_work( int matrix_layout, char uplo, int n, float* ap, float* d, float* e, float* tau ); int LAPACKE_ssptrf( int matrix_layout, char uplo, int n, float* ap, int* ipiv ); int LAPACKE_ssptrf_work( int matrix_layout, char uplo, int n, float* ap, int* ipiv ); int LAPACKE_ssptri( int matrix_layout, char uplo, int n, float* ap, const int* ipiv ); int LAPACKE_ssptri_work( int matrix_layout, char uplo, int n, float* ap, const int* ipiv, float* work ); int LAPACKE_ssptrs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const int* ipiv, float* b, int ldb ); int LAPACKE_ssptrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const int* ipiv, float* b, int ldb ); int LAPACKE_sstebz( char range, char order, int n, float vl, float vu, int il, int iu, float abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit ); int LAPACKE_sstebz_work( char range, char order, int n, float vl, float vu, int il, int iu, float abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork ); int LAPACKE_sstedc( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_sstedc_work( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstegr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_sstegr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstein( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, float* z, int ldz, int* ifailv ); int LAPACKE_sstein_work( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, float* z, int ldz, float* work, int* iwork, int* ifailv ); int LAPACKE_sstemr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, float* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_sstemr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, float* z, int ldz, int nzc, int* isuppz, int* tryrac, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssteqr( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_ssteqr_work( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz, float* work ); int LAPACKE_ssterf( int n, float* d, float* e ); int LAPACKE_ssterf_work( int n, float* d, float* e ); int LAPACKE_sstev( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_sstev_work( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz, float* work ); int LAPACKE_sstevd( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_sstevd_work( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstevr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_sstevr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstevx( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_sstevx_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssycon( int matrix_layout, char uplo, int n, const float* a, int lda, const int* ipiv, float anorm, float* rcond ); int LAPACKE_ssycon_work( int matrix_layout, char uplo, int n, const float* a, int lda, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_ssyconv( int matrix_layout, char uplo, char way, int n, float* a, int lda, const int* ipiv, float* e ); int LAPACKE_ssyconv_work( int matrix_layout, char uplo, char way, int n, float* a, int lda, const int* ipiv, float* e ); int LAPACKE_ssyequb( int matrix_layout, char uplo, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_ssyequb_work( int matrix_layout, char uplo, int n, const float* a, int lda, float* s, float* scond, float* amax, float* work ); int LAPACKE_ssyev( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyev_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork ); int LAPACKE_ssyevd( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyevd_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevr( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_ssyevr_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevx( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssyevx_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssygst( int matrix_layout, int itype, char uplo, int n, float* a, int lda, const float* b, int ldb ); int LAPACKE_ssygst_work( int matrix_layout, int itype, char uplo, int n, float* a, int lda, const float* b, int ldb ); int LAPACKE_ssygv( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w ); int LAPACKE_ssygv_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w, float* work, int lwork ); int LAPACKE_ssygvd( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w ); int LAPACKE_ssygvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssygvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* a, int lda, float* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssygvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* a, int lda, float* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssyrfs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_ssyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_ssyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_ssyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_ssysv( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_rook( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssysv_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* a, int lda, float* af, int ldaf, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_ssysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* a, int lda, float* af, int ldaf, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int lwork, int* iwork ); int LAPACKE_ssysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_ssysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_ssyswapr( int matrix_layout, char uplo, int n, float* a, int lda, int i1, int i2 ); int LAPACKE_ssyswapr_work( int matrix_layout, char uplo, int n, float* a, int lda, int i1, int i2 ); int LAPACKE_ssytrd( int matrix_layout, char uplo, int n, float* a, int lda, float* d, float* e, float* tau ); int LAPACKE_ssytrd_work( int matrix_layout, char uplo, int n, float* a, int lda, float* d, float* e, float* tau, float* work, int lwork ); int LAPACKE_ssytrf( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv ); int LAPACKE_ssytrf_rook( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv ); int LAPACKE_ssytrf_rook_work( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv, float* work, int lwork ); int LAPACKE_ssytrf_work( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv, float* work, int lwork ); int LAPACKE_ssytri( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv ); int LAPACKE_ssytri2( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv ); int LAPACKE_ssytri2_work( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, float* work, int lwork ); int LAPACKE_ssytri2x( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, int nb ); int LAPACKE_ssytri2x_work( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, float* work, int nb ); int LAPACKE_ssytri_work( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, float* work ); int LAPACKE_ssytrs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs2( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb, float* work ); int LAPACKE_ssytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_stbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const float* ab, int ldab, float* rcond ); int LAPACKE_stbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const float* ab, int ldab, float* rcond, float* work, int* iwork ); int LAPACKE_stbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr ); int LAPACKE_stbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_stbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_stbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_stfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, float alpha, const float* a, float* b, int ldb ); int LAPACKE_stfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, float alpha, const float* a, float* b, int ldb ); int LAPACKE_stftri( int matrix_layout, char transr, char uplo, char diag, int n, float* a ); int LAPACKE_stftri_work( int matrix_layout, char transr, char uplo, char diag, int n, float* a ); int LAPACKE_stfttp( int matrix_layout, char transr, char uplo, int n, const float* arf, float* ap ); int LAPACKE_stfttp_work( int matrix_layout, char transr, char uplo, int n, const float* arf, float* ap ); int LAPACKE_stfttr( int matrix_layout, char transr, char uplo, int n, const float* arf, float* a, int lda ); int LAPACKE_stfttr_work( int matrix_layout, char transr, char uplo, int n, const float* arf, float* a, int lda ); int LAPACKE_stgevc( int matrix_layout, char side, char howmny, const int* select, int n, const float* s, int lds, const float* p, int ldp, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m ); int LAPACKE_stgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const float* s, int lds, const float* p, int ldp, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, float* work ); int LAPACKE_stgexc( int matrix_layout, int wantq, int wantz, int n, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz, int* ifst, int* ilst ); int LAPACKE_stgexc_work( int matrix_layout, int wantq, int wantz, int n, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz, int* ifst, int* ilst, float* work, int lwork ); int LAPACKE_stgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz, int* m, float* pl, float* pr, float* dif ); int LAPACKE_stgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz, int* m, float* pl, float* pr, float* dif, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_stgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, float* a, int lda, float* b, int ldb, float tola, float tolb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* ncycle ); int LAPACKE_stgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, float* a, int lda, float* b, int ldb, float tola, float tolb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, float* work, int* ncycle ); int LAPACKE_stgsna( int matrix_layout, char job, char howmny, const int* select, int n, const float* a, int lda, const float* b, int ldb, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* dif, int mm, int* m ); int LAPACKE_stgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const float* a, int lda, const float* b, int ldb, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* dif, int mm, int* m, float* work, int lwork, int* iwork ); int LAPACKE_stgsyl( int matrix_layout, char trans, int ijob, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, const float* d, int ldd, const float* e, int lde, float* f, int ldf, float* scale, float* dif ); int LAPACKE_stgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, const float* d, int ldd, const float* e, int lde, float* f, int ldf, float* scale, float* dif, float* work, int lwork, int* iwork ); int LAPACKE_stpcon( int matrix_layout, char norm, char uplo, char diag, int n, const float* ap, float* rcond ); int LAPACKE_stpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const float* ap, float* rcond, float* work, int* iwork ); int LAPACKE_stpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb ); int LAPACKE_stpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb, float* work ); int LAPACKE_stpqrt( int matrix_layout, int m, int n, int l, int nb, float* a, int lda, float* b, int ldb, float* t, int ldt ); int LAPACKE_stpqrt2( int matrix_layout, int m, int n, int l, float* a, int lda, float* b, int ldb, float* t, int ldt ); int LAPACKE_stpqrt2_work( int matrix_layout, int m, int n, int l, float* a, int lda, float* b, int ldb, float* t, int ldt ); int LAPACKE_stpqrt_work( int matrix_layout, int m, int n, int l, int nb, float* a, int lda, float* b, int ldb, float* t, int ldt, float* work ); int LAPACKE_stprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb); int LAPACKE_stprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb, float* work, int ldwork ); int LAPACKE_stprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr ); int LAPACKE_stprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_stptri( int matrix_layout, char uplo, char diag, int n, float* ap ); int LAPACKE_stptri_work( int matrix_layout, char uplo, char diag, int n, float* ap ); int LAPACKE_stptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_stptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_stpttf( int matrix_layout, char transr, char uplo, int n, const float* ap, float* arf ); int LAPACKE_stpttf_work( int matrix_layout, char transr, char uplo, int n, const float* ap, float* arf ); int LAPACKE_stpttr( int matrix_layout, char uplo, int n, const float* ap, float* a, int lda ); int LAPACKE_stpttr_work( int matrix_layout, char uplo, int n, const float* ap, float* a, int lda ); int LAPACKE_strcon( int matrix_layout, char norm, char uplo, char diag, int n, const float* a, int lda, float* rcond ); int LAPACKE_strcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const float* a, int lda, float* rcond, float* work, int* iwork ); int LAPACKE_strevc( int matrix_layout, char side, char howmny, int* select, int n, const float* t, int ldt, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m ); int LAPACKE_strevc_work( int matrix_layout, char side, char howmny, int* select, int n, const float* t, int ldt, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, float* work ); int LAPACKE_strexc( int matrix_layout, char compq, int n, float* t, int ldt, float* q, int ldq, int* ifst, int* ilst ); int LAPACKE_strexc_work( int matrix_layout, char compq, int n, float* t, int ldt, float* q, int ldq, int* ifst, int* ilst, float* work ); int LAPACKE_strrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr ); int LAPACKE_strrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_strsen( int matrix_layout, char job, char compq, const int* select, int n, float* t, int ldt, float* q, int ldq, float* wr, float* wi, int* m, float* s, float* sep ); int LAPACKE_strsen_work( int matrix_layout, char job, char compq, const int* select, int n, float* t, int ldt, float* q, int ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_strsna( int matrix_layout, char job, char howmny, const int* select, int n, const float* t, int ldt, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* sep, int mm, int* m ); int LAPACKE_strsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const float* t, int ldt, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* sep, int mm, int* m, float* work, int ldwork, int* iwork ); int LAPACKE_strsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, float* scale ); int LAPACKE_strsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, float* scale ); int LAPACKE_strtri( int matrix_layout, char uplo, char diag, int n, float* a, int lda ); int LAPACKE_strtri_work( int matrix_layout, char uplo, char diag, int n, float* a, int lda ); int LAPACKE_strtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_strtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_strttf( int matrix_layout, char transr, char uplo, int n, const float* a, int lda, float* arf ); int LAPACKE_strttf_work( int matrix_layout, char transr, char uplo, int n, const float* a, int lda, float* arf ); int LAPACKE_strttp( int matrix_layout, char uplo, int n, const float* a, int lda, float* ap ); int LAPACKE_strttp_work( int matrix_layout, char uplo, int n, const float* a, int lda, float* ap ); int LAPACKE_stzrzf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_stzrzf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_zbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e ); int LAPACKE_zbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, int lrwork ); int LAPACKE_zbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, MKL_Complex16* vt, int ldvt, MKL_Complex16* u, int ldu, MKL_Complex16* c, int ldc ); int LAPACKE_zbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, MKL_Complex16* vt, int ldvt, MKL_Complex16* u, int ldu, MKL_Complex16* c, int ldc, double* work ); int LAPACKE_zcgesv( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, int* iter ); int LAPACKE_zcgesv_work( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter ); int LAPACKE_zcposv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, int* iter ); int LAPACKE_zcposv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter ); int LAPACKE_zgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq, MKL_Complex16* pt, int ldpt, MKL_Complex16* c, int ldc ); int LAPACKE_zgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq, MKL_Complex16* pt, int ldpt, MKL_Complex16* c, int ldc, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbcon( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbequ( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbequb( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_zgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbtrf( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex16* ab, int ldab, int* ipiv ); int LAPACKE_zgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex16* ab, int ldab, int* ipiv ); int LAPACKE_zgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zgebal( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_zgebal_work( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_zgebrd( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup ); int LAPACKE_zgebrd_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int lwork ); int LAPACKE_zgecon( int matrix_layout, char norm, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond ); int LAPACKE_zgecon_work( int matrix_layout, char norm, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zgeequ( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgeequ_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgeequb( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgeequb_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgees( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs ); int LAPACKE_zgees_work( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zgeesx( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, char sense, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs, double* rconde, double* rcondv ); int LAPACKE_zgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, char sense, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zgeev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr ); int LAPACKE_zgeev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv ); int LAPACKE_zgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgehrd( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgehrd_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex16* a, int lda, double* sva, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, double* stat, int* istat ); int LAPACKE_zgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex16* a, int lda, double* sva, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* cwork, int lwork, double* rwork, int lrwork, int* iwork ); int LAPACKE_zgelq2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgelq2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work ); int LAPACKE_zgelqf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgelqf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgels( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zgels_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zgelsd( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_zgelsd_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zgelss( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_zgelss_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgelsy( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* jpvt, double rcond, int* rank ); int LAPACKE_zgelsy_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* jpvt, double rcond, int* rank, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc ); int LAPACKE_zgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc, MKL_Complex16* work ); int LAPACKE_zgeqlf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqlf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqp3( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau ); int LAPACKE_zgeqp3_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgeqpf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau ); int LAPACKE_zgeqpf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork ); int LAPACKE_zgeqr2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqr2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work ); int LAPACKE_zgeqrf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqrf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqrfp( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqrfp_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqrt( int matrix_layout, int m, int n, int nb, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt3( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt3_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt_work( int matrix_layout, int m, int n, int nb, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt, MKL_Complex16* work ); int LAPACKE_zgerfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zgerfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgerqf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgerqf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgesdd( int matrix_layout, char jobz, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt ); int LAPACKE_zgesdd_work( int matrix_layout, char jobz, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zgesv( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgesv_work( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, double* superb ); int LAPACKE_zgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, int* ns, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, int* superb ); int LAPACKE_zgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, int* ns, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex16 * a, int lda, double* sva, int mv, MKL_Complex16* v, int ldv, double* stat ); int LAPACKE_zgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex16* a, int lda, double* sva, int mv, MKL_Complex16* v, int ldv, MKL_Complex16* cwork, int lwork, double* rwork, int lrwork ); int LAPACKE_zgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_zgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgetf2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetf2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetri( int matrix_layout, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zgetri_work( int matrix_layout, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zgetrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgetrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zggbal( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale ); int LAPACKE_zggbal_work( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work ); int LAPACKE_zgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr ); int LAPACKE_zgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr ); int LAPACKE_zgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, double* rconde, double* rcondv ); int LAPACKE_zggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int liwork, int* bwork ); int LAPACKE_zggev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr ); int LAPACKE_zggev3( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr ); int LAPACKE_zggev3_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zggev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv ); int LAPACKE_zggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* bwork ); int LAPACKE_zggglm( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y ); int LAPACKE_zggglm_work( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, int lwork ); int LAPACKE_zgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork ); int LAPACKE_zgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zgglse( int matrix_layout, int m, int n, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x ); int LAPACKE_zgglse_work( int matrix_layout, int m, int n, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, int lwork ); int LAPACKE_zggqrf( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub ); int LAPACKE_zggqrf_work( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub, MKL_Complex16* work, int lwork ); int LAPACKE_zggrqf( int matrix_layout, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub ); int LAPACKE_zggrqf_work( int matrix_layout, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub, MKL_Complex16* work, int lwork ); int LAPACKE_zggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork ); int LAPACKE_zggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork ); int LAPACKE_zggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, MKL_Complex16* work, double* rwork, int* iwork ); int LAPACKE_zggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq ); int LAPACKE_zggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq ); int LAPACKE_zggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work ); int LAPACKE_zgtcon( char norm, int n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zgtcon_work( char norm, int n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zgtrfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgtsv( int matrix_layout, int n, int nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, int ldb ); int LAPACKE_zgtsv_work( int matrix_layout, int n, int nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, int ldb ); int LAPACKE_zgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgttrf( int n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv ); int LAPACKE_zgttrf_work( int n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv ); int LAPACKE_zgttrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgttrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhbev( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhbevd( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, const MKL_Complex16* bb, int ldbb, MKL_Complex16* x, int ldx ); int LAPACKE_zhbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, const MKL_Complex16* bb, int ldbb, MKL_Complex16* x, int ldx, MKL_Complex16* work, double* rwork ); int LAPACKE_zhbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhbtrd( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq ); int LAPACKE_zhbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq, MKL_Complex16* work ); int LAPACKE_zhecon( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zhecon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zheequb( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zheequb_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax, MKL_Complex16* work ); int LAPACKE_zheev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zheevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevr( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz ); int LAPACKE_zheevr_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zheevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhegst( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb ); int LAPACKE_zhegst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb ); int LAPACKE_zhegv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w ); int LAPACKE_zhegv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhegvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w ); int LAPACKE_zhegvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhegvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhegvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zherfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zherfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zherfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zherfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zhesv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhesv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zhesvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zhesvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhesvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zhesvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zheswapr( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zheswapr_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zhetrd( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tau ); int LAPACKE_zhetrd_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zhetrf_rook( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zhetrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetri( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zhetri2( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zhetri2_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetri2x( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, int nb ); int LAPACKE_zhetri2x_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int nb ); int LAPACKE_zhetri_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zhetrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work ); int LAPACKE_zhetrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const MKL_Complex16* a, int lda, double beta, MKL_Complex16* c ); int LAPACKE_zhfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const MKL_Complex16* a, int lda, double beta, MKL_Complex16* c ); int LAPACKE_zhgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* t, int ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zhgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* t, int ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhpcon( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zhpcon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zhpev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhpevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhpevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhpevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhpgst( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* ap, const MKL_Complex16* bp ); int LAPACKE_zhpgst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* ap, const MKL_Complex16* bp ); int LAPACKE_zhpgv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhpgvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhpgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhpgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zhprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zhpsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhpsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhpsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zhpsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zhptrd( int matrix_layout, char uplo, int n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau ); int LAPACKE_zhptrd_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau ); int LAPACKE_zhptrf( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zhptrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zhptri( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv ); int LAPACKE_zhptri_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zhptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhsein( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_zhsein_work( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr ); int LAPACKE_zhseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork ); int LAPACKE_zlacgv( int n, MKL_Complex16* x, int incx ); int LAPACKE_zlacgv_work( int n, MKL_Complex16* x, int incx ); int LAPACKE_zlacn2( int n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); int LAPACKE_zlacn2_work( int n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); int LAPACKE_zlacp2( int matrix_layout, char uplo, int m, int n, const double* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlacp2_work( int matrix_layout, char uplo, int m, int n, const double* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlacpy( int matrix_layout, char uplo, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlacpy_work( int matrix_layout, char uplo, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlag2c( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex8* sa, int ldsa ); int LAPACKE_zlag2c_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex8* sa, int ldsa ); int LAPACKE_zlagge( int matrix_layout, int m, int n, int kl, int ku, const double* d, MKL_Complex16* a, int lda, int* iseed ); int LAPACKE_zlagge_work( int matrix_layout, int m, int n, int kl, int ku, const double* d, MKL_Complex16* a, int lda, int* iseed, MKL_Complex16* work ); int LAPACKE_zlaghe( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed ); int LAPACKE_zlaghe_work( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed, MKL_Complex16* work ); int LAPACKE_zlagsy( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed ); int LAPACKE_zlagsy_work( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed, MKL_Complex16* work ); int LAPACKE_zlapmr( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlapmr_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlapmt( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlapmt_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc ); int LAPACKE_zlarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc, MKL_Complex16* work, int ldwork ); int LAPACKE_zlarfg( int n, MKL_Complex16* alpha, MKL_Complex16* x, int incx, MKL_Complex16* tau ); int LAPACKE_zlarfg_work( int n, MKL_Complex16* alpha, MKL_Complex16* x, int incx, MKL_Complex16* tau ); int LAPACKE_zlarft( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* tau, MKL_Complex16* t, int ldt ); int LAPACKE_zlarft_work( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* tau, MKL_Complex16* t, int ldt ); int LAPACKE_zlarfx( int matrix_layout, char side, int m, int n, const MKL_Complex16* v, MKL_Complex16 tau, MKL_Complex16* c, int ldc, MKL_Complex16* work ); int LAPACKE_zlarfx_work( int matrix_layout, char side, int m, int n, const MKL_Complex16* v, MKL_Complex16 tau, MKL_Complex16* c, int ldc, MKL_Complex16* work ); int LAPACKE_zlarnv( int idist, int* iseed, int n, MKL_Complex16* x ); int LAPACKE_zlarnv_work( int idist, int* iseed, int n, MKL_Complex16* x ); int LAPACKE_zlascl( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_zlascl_work( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_zlaset( int matrix_layout, char uplo, int m, int n, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16* a, int lda ); int LAPACKE_zlaset_work( int matrix_layout, char uplo, int m, int n, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16* a, int lda ); int LAPACKE_zlaswp( int matrix_layout, int n, MKL_Complex16* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_zlaswp_work( int matrix_layout, int n, MKL_Complex16* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_zlatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, MKL_Complex16* a, int lda ); int LAPACKE_zlatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, MKL_Complex16* a, int lda, MKL_Complex16* work ); int LAPACKE_zlauum( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zlauum_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpbcon( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double anorm, double* rcond ); int LAPACKE_zpbcon_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zpbequ( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_zpbequ_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_zpbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zpbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpbstf( int matrix_layout, char uplo, int n, int kb, MKL_Complex16* bb, int ldbb ); int LAPACKE_zpbstf_work( int matrix_layout, char uplo, int n, int kb, MKL_Complex16* bb, int ldbb ); int LAPACKE_zpbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zpbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpbtrf( int matrix_layout, char uplo, int n, int kd, MKL_Complex16* ab, int ldab ); int LAPACKE_zpbtrf_work( int matrix_layout, char uplo, int n, int kd, MKL_Complex16* ab, int ldab ); int LAPACKE_zpbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpftrf( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftrf_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftri( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftri_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_zpftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_zpocon( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond ); int LAPACKE_zpocon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zpoequ( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zpoequ_work( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zpoequb( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zpoequb_work( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zporfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zporfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zposv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zposv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zpotrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrf2( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrf2_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotri( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotri_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zpotrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zppcon( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double anorm, double* rcond ); int LAPACKE_zppcon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zppequ( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double* s, double* scond, double* amax ); int LAPACKE_zppequ_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double* s, double* scond, double* amax ); int LAPACKE_zpprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zpprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zppsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zppsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpptrf( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptri( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptri_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zpptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zpstrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* piv, int* rank, double tol ); int LAPACKE_zpstrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* piv, int* rank, double tol, double* work ); int LAPACKE_zptcon( int n, const double* d, const MKL_Complex16* e, double anorm, double* rcond ); int LAPACKE_zptcon_work( int n, const double* d, const MKL_Complex16* e, double anorm, double* rcond, double* work ); int LAPACKE_zpteqr( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz ); int LAPACKE_zpteqr_work( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz, double* work ); int LAPACKE_zptrfs( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zptrfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zptsv( int matrix_layout, int n, int nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zptsv_work( int matrix_layout, int n, int nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zptsvx( int matrix_layout, char fact, int n, int nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zptsvx_work( int matrix_layout, char fact, int n, int nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpttrf( int n, double* d, MKL_Complex16* e ); int LAPACKE_zpttrf_work( int n, double* d, MKL_Complex16* e ); int LAPACKE_zpttrs( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zpttrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zspcon( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zspcon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zsprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zsprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zspsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zspsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zsptrf( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zsptrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zsptri( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv ); int LAPACKE_zsptri_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zsptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zstedc( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz ); int LAPACKE_zstedc_work( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zstegr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz ); int LAPACKE_zstegr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_zstein( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, int ldz, int* ifailv ); int LAPACKE_zstein_work( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, int ldz, double* work, int* iwork, int* ifailv ); int LAPACKE_zstemr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, MKL_Complex16* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_zstemr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, MKL_Complex16* z, int ldz, int nzc, int* isuppz, int* tryrac, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_zsteqr( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz ); int LAPACKE_zsteqr_work( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz, double* work ); int LAPACKE_zsycon( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zsycon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zsyconv( int matrix_layout, char uplo, char way, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* e ); int LAPACKE_zsyconv_work( int matrix_layout, char uplo, char way, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* e ); int LAPACKE_zsyequb( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zsyequb_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax, MKL_Complex16* work ); int LAPACKE_zsyr( int matrix_layout, char uplo, int n, MKL_Complex16 alpha, const MKL_Complex16* x, int incx, MKL_Complex16* a, int lda ); int LAPACKE_zsyr_work( int matrix_layout, char uplo, int n, MKL_Complex16 alpha, const MKL_Complex16* x, int incx, MKL_Complex16* a, int lda ); int LAPACKE_zsyrfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zsyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zsyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zsyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zsysv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_rook( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsysv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zsysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zsysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zsysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zsyswapr( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zsyswapr_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zsytrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zsytrf_rook( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zsytrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytri( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zsytri2( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zsytri2_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytri2x( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, int nb ); int LAPACKE_zsytri2x_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int nb ); int LAPACKE_zsytri_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zsytrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work ); int LAPACKE_zsytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_ztbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex16* ab, int ldab, double* rcond ); int LAPACKE_ztbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex16* ab, int ldab, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_ztbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_ztbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_ztbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_ztbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_ztfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex16 alpha, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_ztfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex16 alpha, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_ztftri( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex16* a ); int LAPACKE_ztftri_work( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex16* a ); int LAPACKE_ztfttp( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* ap ); int LAPACKE_ztfttp_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* ap ); int LAPACKE_ztfttr( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* a, int lda ); int LAPACKE_ztfttr_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* a, int lda ); int LAPACKE_ztgevc( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex16* s, int lds, const MKL_Complex16* p, int ldp, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m ); int LAPACKE_ztgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex16* s, int lds, const MKL_Complex16* p, int ldp, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, MKL_Complex16* work, double* rwork ); int LAPACKE_ztgexc( int matrix_layout, int wantq, int wantz, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int ifst, int ilst ); int LAPACKE_ztgexc_work( int matrix_layout, int wantq, int wantz, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int ifst, int ilst ); int LAPACKE_ztgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int* m, double* pl, double* pr, double* dif ); int LAPACKE_ztgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, int lwork, int* iwork, int liwork ); int LAPACKE_ztgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* ncycle ); int LAPACKE_ztgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, MKL_Complex16* work, int* ncycle ); int LAPACKE_ztgsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* dif, int mm, int* m ); int LAPACKE_ztgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* dif, int mm, int* m, MKL_Complex16* work, int lwork, int* iwork ); int LAPACKE_ztgsyl( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, const MKL_Complex16* d, int ldd, const MKL_Complex16* e, int lde, MKL_Complex16* f, int ldf, double* scale, double* dif ); int LAPACKE_ztgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, const MKL_Complex16* d, int ldd, const MKL_Complex16* e, int lde, MKL_Complex16* f, int ldf, double* scale, double* dif, MKL_Complex16* work, int lwork, int* iwork ); int LAPACKE_ztpcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* ap, double* rcond ); int LAPACKE_ztpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_ztpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_ztpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work ); int LAPACKE_ztpqrt( int matrix_layout, int m, int n, int l, int nb, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt ); int LAPACKE_ztpqrt2( int matrix_layout, int m, int n, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt ); int LAPACKE_ztpqrt2_work( int matrix_layout, int m, int n, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt ); int LAPACKE_ztpqrt_work( int matrix_layout, int m, int n, int l, int nb, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt, MKL_Complex16* work ); int LAPACKE_ztprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb); int LAPACKE_ztprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work, int ldwork ); int LAPACKE_ztprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_ztprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_ztptri( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* ap ); int LAPACKE_ztptri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* ap ); int LAPACKE_ztptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_ztptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_ztpttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* arf ); int LAPACKE_ztpttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* arf ); int LAPACKE_ztpttr( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* a, int lda ); int LAPACKE_ztpttr_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* a, int lda ); int LAPACKE_ztrcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* a, int lda, double* rcond ); int LAPACKE_ztrcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* a, int lda, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_ztrevc( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m ); int LAPACKE_ztrevc_work( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, MKL_Complex16* work, double* rwork ); int LAPACKE_ztrexc( int matrix_layout, char compq, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, int ifst, int ilst ); int LAPACKE_ztrexc_work( int matrix_layout, char compq, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, int ifst, int ilst ); int LAPACKE_ztrrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_ztrrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_ztrsen( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, MKL_Complex16* w, int* m, double* s, double* sep ); int LAPACKE_ztrsen_work( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, int lwork ); int LAPACKE_ztrsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* t, int ldt, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* sep, int mm, int* m ); int LAPACKE_ztrsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* t, int ldt, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* sep, int mm, int* m, MKL_Complex16* work, int ldwork, double* rwork ); int LAPACKE_ztrsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, double* scale ); int LAPACKE_ztrsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, double* scale ); int LAPACKE_ztrtri( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* a, int lda ); int LAPACKE_ztrtri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* a, int lda ); int LAPACKE_ztrtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_ztrtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_ztrttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* arf ); int LAPACKE_ztrttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* arf ); int LAPACKE_ztrttp( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* ap ); int LAPACKE_ztrttp_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* ap ); int LAPACKE_ztzrzf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_ztzrzf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunbdb( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2 ); int LAPACKE_zunbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, int lwork ); int LAPACKE_zuncsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t ); int LAPACKE_zuncsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x21, int ldx21, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t ); int LAPACKE_zuncsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x21, int ldx21, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork ); int LAPACKE_zuncsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork ); int LAPACKE_zungbr( int matrix_layout, char vect, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungbr_work( int matrix_layout, char vect, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunghr( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zunghr_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunglq( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zunglq_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungql( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungql_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungqr( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungqr_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungrq( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungrq_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungtr( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungtr_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunmbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmql( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmql_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmrq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zupgtr( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, int ldq ); int LAPACKE_zupgtr_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, int ldq, MKL_Complex16* work ); int LAPACKE_zupmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zupmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work ); void LAPACKE_ilaver( int* vers_major, int* vers_minor, int* vers_patch ); void LAPACKE_xerbla( const char *name, int info ); int LAPACKE_chesv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chesv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf_aa( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_chetrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_dsysv_aa( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsytrf_aa( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv ); int LAPACKE_dsytrf_aa_work( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv, double* work, int lwork ); int LAPACKE_dsytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_ssysv_aa( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssytrf_aa( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv ); int LAPACKE_ssytrf_aa_work( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv, float* work, int lwork ); int LAPACKE_ssytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_zhesv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhesv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf_aa( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zhetrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_cgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc ); int LAPACKE_cgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqr( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize ); int LAPACKE_cgeqr_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize, MKL_Complex8* work, int lwork ); int LAPACKE_dgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc ); int LAPACKE_dgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc, double* work, int lwork ); int LAPACKE_dgeqr( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize ); int LAPACKE_dgeqr_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize, double* work, int lwork ); int LAPACKE_sgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc ); int LAPACKE_sgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc, float* work, int lwork ); int LAPACKE_sgeqr( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize ); int LAPACKE_sgeqr_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize, float* work, int lwork ); int LAPACKE_zgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc ); int LAPACKE_zgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqr( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize ); int LAPACKE_zgeqr_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize, MKL_Complex16* work, int lwork ); int LAPACKE_cgelq( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize ); int LAPACKE_cgelq_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize, MKL_Complex8* work, int lwork ); int LAPACKE_cgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc ); int LAPACKE_cgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_dgelq( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize ); int LAPACKE_dgelq_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize, double* work, int lwork ); int LAPACKE_dgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc ); int LAPACKE_dgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc, double* work, int lwork ); int LAPACKE_sgelq( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize ); int LAPACKE_sgelq_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize, float* work, int lwork ); int LAPACKE_sgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc ); int LAPACKE_sgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc, float* work, int lwork ); int LAPACKE_zgelq( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize ); int LAPACKE_zgelq_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize, MKL_Complex16* work, int lwork ); int LAPACKE_zgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc ); int LAPACKE_zgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_cgetsls( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_dgetsls( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* work, int lwork ); int LAPACKE_sgetsls( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* work, int lwork ); int LAPACKE_zgetsls( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_checon_3( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond ); int LAPACKE_checon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_chesv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chesv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf_rk( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv ); int LAPACKE_chetrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetri_3( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv ); int LAPACKE_chetri_3_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csycon_3( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond ); int LAPACKE_csycon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_csysv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csysv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csytrf_aa( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_csytrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytrf_rk( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv ); int LAPACKE_csytrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytri_3( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv ); int LAPACKE_csytri_3_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_dsycon_3( int matrix_layout, char uplo, int n, const double* a, int lda, const double* e, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dsycon_3_work( int matrix_layout, char uplo, int n, const double* a, int lda, const double* e, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dsysv_rk( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* e, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* e, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsytrf_rk( int matrix_layout, char uplo, int n, double* a, int lda, double* e, int* ipiv ); int LAPACKE_dsytrf_rk_work( int matrix_layout, char uplo, int n, double* a, int lda, double* e, int* ipiv, double* work, int lwork ); int LAPACKE_dsytri_3( int matrix_layout, char uplo, int n, double* a, int lda, const double* e, const int* ipiv ); int LAPACKE_dsytri_3_work( int matrix_layout, char uplo, int n, double* a, int lda, const double* e, const int* ipiv, double* work, int lwork ); int LAPACKE_dsytrs_3( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* e, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* e, const int* ipiv, double* b, int ldb ); int LAPACKE_ssycon_3( int matrix_layout, char uplo, int n, const float* a, int lda, const float* e, const int* ipiv, float anorm, float* rcond ); int LAPACKE_ssycon_3_work( int matrix_layout, char uplo, int n, const float* a, int lda, const float* e, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_ssysv_rk( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* e, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* e, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssytrf_rk( int matrix_layout, char uplo, int n, float* a, int lda, float* e, int* ipiv ); int LAPACKE_ssytrf_rk_work( int matrix_layout, char uplo, int n, float* a, int lda, float* e, int* ipiv, float* work, int lwork ); int LAPACKE_ssytri_3( int matrix_layout, char uplo, int n, float* a, int lda, const float* e, const int* ipiv ); int LAPACKE_ssytri_3_work( int matrix_layout, char uplo, int n, float* a, int lda, const float* e, const int* ipiv, float* work, int lwork ); int LAPACKE_ssytrs_3( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* e, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* e, const int* ipiv, float* b, int ldb ); int LAPACKE_zhecon_3( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zhecon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zhesv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhesv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf_rk( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv ); int LAPACKE_zhetrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetri_3( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv ); int LAPACKE_zhetri_3_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsycon_3( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zsycon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zsysv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsysv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrf_aa( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zsytrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrf_rk( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv ); int LAPACKE_zsytrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytri_3( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv ); int LAPACKE_zsytri_3_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_chbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_cheev_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheev_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cheevd_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz ); int LAPACKE_cheevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_cheevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_chegv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w ); int LAPACKE_chegv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_dsbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work, int lwork ); int LAPACKE_dsbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsyev_2stage( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyev_2stage_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork ); int LAPACKE_dsyevd_2stage( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dsyevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsyevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsygv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w ); int LAPACKE_dsygv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w, double* work, int lwork ); int LAPACKE_ssbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work, int lwork ); int LAPACKE_ssbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssyev_2stage( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyev_2stage_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork ); int LAPACKE_ssyevd_2stage( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_ssyevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssyevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssygv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w ); int LAPACKE_ssygv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w, float* work, int lwork ); int LAPACKE_zhbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zheev_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheev_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zheevd_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz ); int LAPACKE_zheevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zheevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhegv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w ); int LAPACKE_zhegv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_mkl_cgetrfnp( int matrix_layout, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_mkl_cgetrfnp_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_mkl_dgetrfnp( int matrix_layout, int m, int n, double* a, int lda ); int LAPACKE_mkl_dgetrfnp_work( int matrix_layout, int m, int n, double* a, int lda ); int LAPACKE_mkl_sgetrfnp( int matrix_layout, int m, int n, float* a, int lda ); int LAPACKE_mkl_sgetrfnp_work( int matrix_layout, int m, int n, float* a, int lda ); int LAPACKE_mkl_zgetrfnp( int matrix_layout, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_mkl_zgetrfnp_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_mkl_cgetrinp( int matrix_layout, int n, MKL_Complex8* a, int lda ); int LAPACKE_mkl_cgetrinp_work( int matrix_layout, int n, MKL_Complex8* a, int lda, MKL_Complex8* work, int lwork ); int LAPACKE_mkl_dgetrinp( int matrix_layout, int n, double* a, int lda ); int LAPACKE_mkl_dgetrinp_work( int matrix_layout, int n, double* a, int lda, double* work, int lwork ); int LAPACKE_mkl_sgetrinp( int matrix_layout, int n, float* a, int lda ); int LAPACKE_mkl_sgetrinp_work( int matrix_layout, int n, float* a, int lda, float* work, int lwork ); int LAPACKE_mkl_zgetrinp( int matrix_layout, int n, MKL_Complex16* a, int lda ); int LAPACKE_mkl_zgetrinp_work( int matrix_layout, int n, MKL_Complex16* a, int lda, MKL_Complex16* work, int lwork ); void LAPACKE_set_nancheck( int flag ); int LAPACKE_get_nancheck( ); #line 45 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_pardiso.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" typedef void * _MKL_DSS_HANDLE_t; typedef char _CHARACTER_t; typedef char _CHARACTER_STR_t; typedef long long _LONG_t; typedef float _REAL_t; typedef double _DOUBLE_PRECISION_t; typedef struct { double r, i; } _DOUBLE_COMPLEX_t; #line 123 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 134 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 145 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 156 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 197 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" extern int __cdecl dss_create_ (_MKL_DSS_HANDLE_t *, int const *); extern int __cdecl dss_define_structure_ (_MKL_DSS_HANDLE_t *, int const *, int const *, int const *, int const *, int const *, int const *); extern int __cdecl dss_reorder_ (_MKL_DSS_HANDLE_t *, int const *, int const *); extern int __cdecl dss_factor_real_ (_MKL_DSS_HANDLE_t *, int const *, void const *); extern int __cdecl dss_factor_complex_ (_MKL_DSS_HANDLE_t *, int const *, void const *); extern int __cdecl dss_solve_real_ (_MKL_DSS_HANDLE_t *, int const *, void const *, int const *, void *); extern int __cdecl dss_solve_complex_ (_MKL_DSS_HANDLE_t *, int const *, void const *, int const *, void *); extern int __cdecl dss_statistics_ ( _MKL_DSS_HANDLE_t *, int const *, _CHARACTER_STR_t const *, _DOUBLE_PRECISION_t *); extern int __cdecl dss_delete_ (_MKL_DSS_HANDLE_t const *, int const *); #line 250 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 271 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 27 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_pardiso.h" #line 44 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_pardiso.h" extern void __cdecl pardiso ( _MKL_DSS_HANDLE_t, const int *, const int *, const int *, const int *, const int *, const void *, const int *, const int *, int *, const int *, int *, const int *, void *, void *, int *); extern void __cdecl PARDISO ( _MKL_DSS_HANDLE_t, const int *, const int *, const int *, const int *, const int *, const void *, const int *, const int *, int *, const int *, int *, const int *, void *, void *, int *); extern void __cdecl pardisoinit ( _MKL_DSS_HANDLE_t, const int *, int *); extern void __cdecl PARDISOINIT ( _MKL_DSS_HANDLE_t, const int *, int *); extern void __cdecl pardiso_64 ( _MKL_DSS_HANDLE_t, const long long int *, const long long int *, const long long int *, const long long int *, const long long int *, const void *, const long long int *, const long long int *, long long int *, const long long int *, long long int *, const long long int *, void *, void *, long long int *); extern void __cdecl PARDISO_64 ( _MKL_DSS_HANDLE_t, const long long int *, const long long int *, const long long int *, const long long int *, const long long int *, const void *, const long long int *, const long long int *, long long int *, const long long int *, long long int *, const long long int *, void *, void *, long long int *); extern void __cdecl pardiso_handle_store_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_STORE_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_restore_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_RESTORE_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_delete_64 ( const char*, int *);; extern void __cdecl PARDISO_HANDLE_DELETE_64 ( const char*, int *);; enum PARDISO_ENV_PARAM { PARDISO_OOC_FILE_NAME = 1 }; extern int __cdecl pardiso_getenv (const _MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, char*); extern int __cdecl PARDISO_GETENV (const _MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, char*); extern int __cdecl pardiso_setenv (_MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, const char*); extern int __cdecl PARDISO_SETENV (_MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, const char*); extern void __cdecl pardiso_handle_store ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_STORE ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_restore ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_RESTORE ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_delete ( const char*, int *);; extern void __cdecl PARDISO_HANDLE_DELETE ( const char*, int *);; extern int __cdecl MKL_PARDISO_PIVOT ( const double* aii, double* bii, const double* eps ); extern int __cdecl MKL_PARDISO_PIVOT_ ( const double* aii, double* bii, const double* eps ); extern int __cdecl mkl_pardiso_pivot ( const double* aii, double* bii, const double* eps ); extern int __cdecl mkl_pardiso_pivot_ ( const double* aii, double* bii, const double* eps ); extern void __cdecl pardiso_getdiag ( const _MKL_DSS_HANDLE_t, void *, void *, const int *, int * ); extern void __cdecl pardiso_export ( void *, void *, int *, int *, const int *, const int *, int * ); #line 46 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_sparse_handle.h" #line 42 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_sparse_handle.h" typedef enum { MKL_ZERO_BASED, MKL_ONE_BASED } sparse_matrix_indexing; typedef enum { MKL_C_STYLE, MKL_FORTRAN_STYLE } sparse_matrix_print_styles; typedef enum { MKL_CSR } sparse_matrix_formats; typedef enum { MKL_GENERAL_STRUCTURE, MKL_UPPER_TRIANGULAR, MKL_LOWER_TRIANGULAR, MKL_STRUCTURAL_SYMMETRIC } sparse_matrix_structures; typedef enum { MKL_NO_PRINT, MKL_PRINT } sparse_matrix_message_levels; typedef enum { MKL_SPARSE_CHECKER_SUCCESS = 0, MKL_SPARSE_CHECKER_NON_MONOTONIC = 21, MKL_SPARSE_CHECKER_OUT_OF_RANGE = 22, MKL_SPARSE_CHECKER_NONTRIANGULAR = 23, MKL_SPARSE_CHECKER_NONORDERED = 24} sparse_checker_error_values; typedef struct _sparse_struct { int n, *csr_ia, *csr_ja, check_result[3]; sparse_matrix_indexing indexing; sparse_matrix_structures matrix_structure; sparse_matrix_formats matrix_format; sparse_matrix_message_levels message_level; sparse_matrix_print_styles print_style; } sparse_struct; extern void __cdecl sparse_matrix_checker_init (sparse_struct*); extern sparse_checker_error_values __cdecl sparse_matrix_checker (sparse_struct*); #line 47 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_rci.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" #pragma once __pragma(pack(push, 8)) #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __declspec(allocator) __declspec(restrict) void* __cdecl _calloc_base( size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl calloc( size_t _Count, size_t _Size ); int __cdecl _callnewh( size_t _Size ); __declspec(allocator) void* __cdecl _expand( void* _Block, size_t _Size ); void __cdecl _free_base( void* _Block ); void __cdecl free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _malloc_base( size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl malloc( size_t _Size ); size_t __cdecl _msize_base( void* _Block ); size_t __cdecl _msize( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _realloc_base( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl realloc( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc_base( void* _Block, size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc( void* _Block, size_t _Count, size_t _Size ); void __cdecl _aligned_free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_malloc( size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_malloc( size_t _Size, size_t _Alignment, size_t _Offset ); size_t __cdecl _aligned_msize( void* _Block, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_realloc( void* _Block, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_realloc( void* _Block, size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment ); #line 225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" #pragma once __pragma(pack(push, 8)) typedef int (__cdecl* _CoreCrtSecureSearchSortCompareFunction)(void*, void const*, void const*); typedef int (__cdecl* _CoreCrtNonSecureSearchSortCompareFunction)(void const*, void const*); void* __cdecl bsearch_s( void const* _Key, void const* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void __cdecl qsort_s( void* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl bsearch( void const* _Key, void const* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void __cdecl qsort( void* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lfind_s( void const* _Key, void const* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lsearch_s( void const* _Key, void* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); #line 185 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lfind" ". See online help for details.")) void* __cdecl lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lsearch" ". See online help for details.")) void* __cdecl lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma once __pragma(pack(push, 8)) errno_t __cdecl _itow_s( int _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _itow(int _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ltow_s( long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ltow(long _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ultow_s( unsigned long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ultow(unsigned long _Value, wchar_t *_Buffer, int _Radix); double __cdecl wcstod( wchar_t const* _String, wchar_t** _EndPtr ); double __cdecl _wcstod_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); long __cdecl wcstol( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long __cdecl _wcstol_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl wcstoll( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long long __cdecl _wcstoll_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl wcstoul( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long __cdecl _wcstoul_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl wcstoull( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long long __cdecl _wcstoull_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long double __cdecl wcstold( wchar_t const* _String, wchar_t** _EndPtr ); long double __cdecl _wcstold_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); float __cdecl wcstof( wchar_t const* _String, wchar_t** _EndPtr ); float __cdecl _wcstof_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); double __cdecl _wtof( wchar_t const* _String ); double __cdecl _wtof_l( wchar_t const* _String, _locale_t _Locale ); int __cdecl _wtoi( wchar_t const* _String ); int __cdecl _wtoi_l( wchar_t const* _String, _locale_t _Locale ); long __cdecl _wtol( wchar_t const* _String ); long __cdecl _wtol_l( wchar_t const* _String, _locale_t _Locale ); long long __cdecl _wtoll( wchar_t const* _String ); long long __cdecl _wtoll_l( wchar_t const* _String, _locale_t _Locale ); errno_t __cdecl _i64tow_s( __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _i64tow( __int64 _Value, wchar_t* _Buffer, int _Radix ); errno_t __cdecl _ui64tow_s( unsigned __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ui64tow( unsigned __int64 _Value, wchar_t* _Buffer, int _Radix ); __int64 __cdecl _wtoi64( wchar_t const* _String ); __int64 __cdecl _wtoi64_l( wchar_t const* _String, _locale_t _Locale ); __int64 __cdecl _wcstoi64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); __int64 __cdecl _wcstoi64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _wcstoui64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned __int64 __cdecl _wcstoui64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); __declspec(allocator) wchar_t* __cdecl _wfullpath( wchar_t* _Buffer, wchar_t const* _Path, size_t _BufferCount ); errno_t __cdecl _wmakepath_s( wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext ); #line 361 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wmakepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wmakepath( wchar_t *_Buffer, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext); #pragma warning(pop) void __cdecl _wperror( wchar_t const* _ErrorMessage ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsplitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsplitpath( wchar_t const* _FullPath, wchar_t* _Drive, wchar_t* _Dir, wchar_t* _Filename, wchar_t* _Ext ); errno_t __cdecl _wsplitpath_s( wchar_t const* _FullPath, wchar_t* _Drive, size_t _DriveCount, wchar_t* _Dir, size_t _DirCount, wchar_t* _Filename, size_t _FilenameCount, wchar_t* _Ext, size_t _ExtCount ); errno_t __cdecl _wdupenv_s( wchar_t** _Buffer, size_t* _BufferCount, wchar_t const* _VarName ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wdupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wgetenv( wchar_t const* _VarName ); errno_t __cdecl _wgetenv_s( size_t* _RequiredCount, wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _VarName ); #line 438 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" int __cdecl _wputenv( wchar_t const* _EnvString ); errno_t __cdecl _wputenv_s( wchar_t const* _Name, wchar_t const* _Value ); errno_t __cdecl _wsearchenv_s( wchar_t const* _Filename, wchar_t const* _VarName, wchar_t* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsearchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsearchenv(wchar_t const* _Filename, wchar_t const* _VarName, wchar_t *_ResultPath); int __cdecl _wsystem( wchar_t const* _Command ); __pragma(pack(pop)) #line 16 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #pragma once __pragma(pack(push, 8)) #line 29 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 43 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 71 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 79 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" __pragma(pack(pop)) #line 17 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __pragma(pack(push, 8)) void __cdecl _swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(noreturn) void __cdecl exit( int _Code); __declspec(noreturn) void __cdecl _exit( int _Code); __declspec(noreturn) void __cdecl _Exit( int _Code); __declspec(noreturn) void __cdecl quick_exit( int _Code); __declspec(noreturn) void __cdecl abort(void); unsigned int __cdecl _set_abort_behavior( unsigned int _Flags, unsigned int _Mask ); typedef int (__cdecl* _onexit_t)(void); #line 117 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 140 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl atexit(void (__cdecl*)(void)); _onexit_t __cdecl _onexit( _onexit_t _Func); int __cdecl at_quick_exit(void (__cdecl*)(void)); typedef void (__cdecl* _purecall_handler)(void); typedef void (__cdecl* _invalid_parameter_handler)( wchar_t const*, wchar_t const*, wchar_t const*, unsigned int, uintptr_t ); _purecall_handler __cdecl _set_purecall_handler( _purecall_handler _Handler ); _purecall_handler __cdecl _get_purecall_handler(void); _invalid_parameter_handler __cdecl _set_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_invalid_parameter_handler(void); _invalid_parameter_handler __cdecl _set_thread_local_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_thread_local_invalid_parameter_handler(void); #line 199 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl _set_error_mode( int _Mode); int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); unsigned long* __cdecl __doserrno(void); errno_t __cdecl _set_doserrno( unsigned long _Value); errno_t __cdecl _get_doserrno( unsigned long * _Value); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __sys_errlist(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int * __cdecl __sys_nerr(void); void __cdecl perror( char const* _ErrMsg); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_pgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __p__pgmptr (void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_wpgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t** __cdecl __p__wpgmptr(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_fmode" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int* __cdecl __p__fmode (void); #line 253 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" errno_t __cdecl _get_pgmptr ( char** _Value); errno_t __cdecl _get_wpgmptr( wchar_t** _Value); errno_t __cdecl _set_fmode ( int _Mode ); errno_t __cdecl _get_fmode ( int* _PMode); typedef struct _div_t { int quot; int rem; } div_t; typedef struct _ldiv_t { long quot; long rem; } ldiv_t; typedef struct _lldiv_t { long long quot; long long rem; } lldiv_t; int __cdecl abs ( int _Number); long __cdecl labs ( long _Number); long long __cdecl llabs ( long long _Number); __int64 __cdecl _abs64( __int64 _Number); unsigned short __cdecl _byteswap_ushort( unsigned short _Number); unsigned long __cdecl _byteswap_ulong ( unsigned long _Number); unsigned __int64 __cdecl _byteswap_uint64( unsigned __int64 _Number); div_t __cdecl div ( int _Numerator, int _Denominator); ldiv_t __cdecl ldiv ( long _Numerator, long _Denominator); lldiv_t __cdecl lldiv( long long _Numerator, long long _Denominator); #pragma warning (push) #pragma warning (disable:6540) unsigned int __cdecl _rotl( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotl( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotl64( unsigned __int64 _Value, int _Shift ); unsigned int __cdecl _rotr( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotr( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotr64( unsigned __int64 _Value, int _Shift ); #pragma warning (pop) void __cdecl srand( unsigned int _Seed); int __cdecl rand(void); #line 380 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma pack(push, 4) typedef struct { unsigned char ld[10]; } _LDOUBLE; #pragma pack(pop) #line 410 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" typedef struct { double x; } _CRT_DOUBLE; typedef struct { float f; } _CRT_FLOAT; typedef struct { long double x; } _LONGDOUBLE; #pragma pack(push, 4) typedef struct { unsigned char ld12[12]; } _LDBL12; #pragma pack(pop) double __cdecl atof ( char const* _String); int __cdecl atoi ( char const* _String); long __cdecl atol ( char const* _String); long long __cdecl atoll ( char const* _String); __int64 __cdecl _atoi64( char const* _String); double __cdecl _atof_l ( char const* _String, _locale_t _Locale); int __cdecl _atoi_l ( char const* _String, _locale_t _Locale); long __cdecl _atol_l ( char const* _String, _locale_t _Locale); long long __cdecl _atoll_l ( char const* _String, _locale_t _Locale); __int64 __cdecl _atoi64_l( char const* _String, _locale_t _Locale); int __cdecl _atoflt ( _CRT_FLOAT* _Result, char const* _String); int __cdecl _atodbl ( _CRT_DOUBLE* _Result, char* _String); int __cdecl _atoldbl( _LDOUBLE* _Result, char* _String); int __cdecl _atoflt_l( _CRT_FLOAT* _Result, char const* _String, _locale_t _Locale ); int __cdecl _atodbl_l( _CRT_DOUBLE* _Result, char* _String, _locale_t _Locale ); int __cdecl _atoldbl_l( _LDOUBLE* _Result, char* _String, _locale_t _Locale ); float __cdecl strtof( char const* _String, char** _EndPtr ); float __cdecl _strtof_l( char const* _String, char** _EndPtr, _locale_t _Locale ); double __cdecl strtod( char const* _String, char** _EndPtr ); double __cdecl _strtod_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long double __cdecl strtold( char const* _String, char** _EndPtr ); long double __cdecl _strtold_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long __cdecl strtol( char const* _String, char** _EndPtr, int _Radix ); long __cdecl _strtol_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl strtoll( char const* _String, char** _EndPtr, int _Radix ); long long __cdecl _strtoll_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl strtoul( char const* _String, char** _EndPtr, int _Radix ); unsigned long __cdecl _strtoul_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl strtoull( char const* _String, char** _EndPtr, int _Radix ); unsigned long long __cdecl _strtoull_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); __int64 __cdecl _strtoi64( char const* _String, char** _EndPtr, int _Radix ); __int64 __cdecl _strtoi64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _strtoui64( char const* _String, char** _EndPtr, int _Radix ); unsigned __int64 __cdecl _strtoui64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); errno_t __cdecl _itoa_s( int _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _itoa(int _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _ltoa_s( long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ltoa(long _Value, char *_Buffer, int _Radix); errno_t __cdecl _ultoa_s( unsigned long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ultoa(unsigned long _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _i64toa_s( __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _i64toa( __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ui64toa_s( unsigned __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ui64toa( unsigned __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ecvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _fcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _gcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _gcvt( double _Value, int _DigitCount, char* _Buffer ); #line 838 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl ___mb_cur_max_func(void); int __cdecl ___mb_cur_max_l_func(_locale_t _Locale); int __cdecl mblen( char const* _Ch, size_t _MaxCount ); int __cdecl _mblen_l( char const* _Ch, size_t _MaxCount, _locale_t _Locale ); size_t __cdecl _mbstrlen( char const* _String ); size_t __cdecl _mbstrlen_l( char const* _String, _locale_t _Locale ); size_t __cdecl _mbstrnlen( char const* _String, size_t _MaxCount ); size_t __cdecl _mbstrnlen_l( char const* _String, size_t _MaxCount, _locale_t _Locale ); int __cdecl mbtowc( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes ); int __cdecl _mbtowc_l( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes, _locale_t _Locale ); errno_t __cdecl mbstowcs_s( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "mbstowcs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl mbstowcs( wchar_t *_Dest, char const* _Source, size_t _MaxCount); errno_t __cdecl _mbstowcs_s_l( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_mbstowcs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _mbstowcs_l( wchar_t *_Dest, char const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wctomb_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl wctomb( char* _MbCh, wchar_t _WCh ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctomb_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _wctomb_l( char* _MbCh, wchar_t _WCh, _locale_t _Locale ); errno_t __cdecl wctomb_s( int* _SizeConverted, char* _MbCh, rsize_t _SizeInBytes, wchar_t _WCh ); errno_t __cdecl _wctomb_s_l( int* _SizeConverted, char* _MbCh, size_t _SizeInBytes, wchar_t _WCh, _locale_t _Locale); errno_t __cdecl wcstombs_s( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstombs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl wcstombs( char *_Dest, wchar_t const* _Source, size_t _MaxCount); errno_t __cdecl _wcstombs_s_l( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcstombs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _wcstombs_l( char *_Dest, wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(allocator) char* __cdecl _fullpath( char* _Buffer, char const* _Path, size_t _BufferCount ); errno_t __cdecl _makepath_s( char* _Buffer, size_t _BufferCount, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_makepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _makepath( char *_Buffer, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext); #pragma warning(pop) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_splitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _splitpath( char const* _FullPath, char* _Drive, char* _Dir, char* _Filename, char* _Ext ); errno_t __cdecl _splitpath_s( char const* _FullPath, char* _Drive, size_t _DriveCount, char* _Dir, size_t _DirCount, char* _Filename, size_t _FilenameCount, char* _Ext, size_t _ExtCount ); errno_t __cdecl getenv_s( size_t* _RequiredCount, char* _Buffer, rsize_t _BufferCount, char const* _VarName ); int* __cdecl __p___argc (void); char*** __cdecl __p___argv (void); wchar_t*** __cdecl __p___wargv(void); #line 1164 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" char*** __cdecl __p__environ (void); wchar_t*** __cdecl __p__wenviron(void); #line 1181 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "_dupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl getenv( char const* _VarName ); errno_t __cdecl _dupenv_s( char** _Buffer, size_t* _BufferCount, char const* _VarName ); int __cdecl system( char const* _Command ); #pragma warning (push) #pragma warning (disable:6540) int __cdecl _putenv( char const* _EnvString ); errno_t __cdecl _putenv_s( char const* _Name, char const* _Value ); #pragma warning (pop) errno_t __cdecl _searchenv_s( char const* _Filename, char const* _VarName, char* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_searchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _searchenv(char const* _Filename, char const* _VarName, char *_Buffer); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "SetErrorMode" " " "instead. See online help for details.")) void __cdecl _seterrormode( int _Mode ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Beep" " " "instead. See online help for details.")) void __cdecl _beep( unsigned _Frequency, unsigned _Duration ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Sleep" " " "instead. See online help for details.")) void __cdecl _sleep( unsigned long _Duration ); #pragma warning(push) #pragma warning(disable: 4141) __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ecvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_fcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_gcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl gcvt( double _Value, int _DigitCount, char* _DstBuf ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_itoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl itoa( int _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ltoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ltoa( long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_swab" ". See online help for details.")) void __cdecl swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ultoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ultoa( unsigned long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_putenv" ". See online help for details.")) int __cdecl putenv( char const* _EnvString ); #pragma warning(pop) _onexit_t __cdecl onexit( _onexit_t _Func); __pragma(pack(pop)) #line 24 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" extern void __cdecl MKL_Get_Version (MKLVersion *ver); extern void __cdecl MKL_Get_Version_String (char * buffer, int len); extern void __cdecl MKL_Free_Buffers (void); extern void __cdecl MKL_Thread_Free_Buffers (void); extern long long int __cdecl MKL_Mem_Stat (int* nbuffers); extern long long int __cdecl MKL_Peak_Mem_Usage (int reset); extern void* __cdecl MKL_malloc (size_t size, int align); extern void* __cdecl MKL_calloc (size_t num, size_t size, int align); extern void* __cdecl MKL_realloc (void *ptr, size_t size); extern void __cdecl MKL_free (void *ptr); extern int __cdecl MKL_Disable_Fast_MM (void); extern void __cdecl MKL_Get_Cpu_Clocks (unsigned long long int *); extern double __cdecl MKL_Get_Cpu_Frequency (void); extern double __cdecl MKL_Get_Max_Cpu_Frequency (void); extern double __cdecl MKL_Get_Clocks_Frequency (void); extern int __cdecl MKL_Set_Num_Threads_Local (int nth); extern void __cdecl MKL_Set_Num_Threads (int nth); extern int __cdecl MKL_Get_Max_Threads (void); extern void __cdecl MKL_Set_Num_Stripes (int nstripes); extern int __cdecl MKL_Get_Num_Stripes (void); extern int __cdecl MKL_Domain_Set_Num_Threads (int nth, int MKL_DOMAIN); extern int __cdecl MKL_Domain_Get_Max_Threads (int MKL_DOMAIN); extern void __cdecl MKL_Set_Dynamic (int bool_MKL_DYNAMIC); extern int __cdecl MKL_Get_Dynamic (void); #line 124 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" extern int __cdecl MKL_Enable_Instructions (int); #line 135 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" extern int __cdecl MKL_Set_Interface_Layer (int code); extern int __cdecl MKL_Set_Threading_Layer (int code); typedef void (* XerblaEntry) (const char * Name, const int * Num, const int Len); extern XerblaEntry __cdecl mkl_set_xerbla (XerblaEntry xerbla); typedef int (* ProgressEntry) (int* thread, int* step, char* stage, int stage_len); extern ProgressEntry __cdecl mkl_set_progress (ProgressEntry progress); extern int __cdecl MKL_CBWR_Get (int); extern int __cdecl MKL_CBWR_Set (int); extern int __cdecl MKL_CBWR_Get_Auto_Branch (void); extern int __cdecl MKL_Set_Env_Mode (int); extern int __cdecl MKL_Verbose (int); extern int __cdecl MKL_Verbose_Output_File (char *); typedef void (* MKLExitHandler)(int why); extern void __cdecl MKL_Set_Exit_Handler (MKLExitHandler h);; extern int __cdecl MKL_Set_Memory_Limit (int mem_type,size_t limit);; enum { MKL_BLACS_CUSTOM = 0, MKL_BLACS_MSMPI = 1, MKL_BLACS_INTELMPI = 2, MKL_BLACS_MPICH2 = 3, MKL_BLACS_LASTMPI = 4 }; int MKL_Set_mpi(int vendor, const char *custom_library_name); extern void __cdecl MKL_Finalize (void);; #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_rci.h" #line 38 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_rci.h" extern void __cdecl dcsrilu0 (const int *n, const double *a, const int *ia, const int *ja, double *alu, const int *ipar, const double *dpar,int *ierr); extern void __cdecl dcsrilut (const int *n, const double *a, const int *ia, const int *ja, double *alut,int *ialut, int *jalut, const double * tol, const int *maxfil, const int *ipar, const double *dpar,int *ierr); extern void __cdecl DCSRILU0 (const int *n, const double *a, const int *ia, const int *ja, double *alu, const int *ipar, const double *dpar,int *ierr); extern void __cdecl DCSRILUT (const int *n, const double *a, const int *ia, const int *ja, double *alut,int *ialut, int *jalut, const double * tol, const int *maxfil, const int *ipar, const double *dpar,int *ierr); extern void __cdecl dcg_init (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcg_check (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcg (const int *n, double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcg_get (const int *n, const double *x, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl dcgmrhs_init (const int *n, const double *x, const int* nRhs, const double *b, const int *method, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcgmrhs_check (const int *n, const double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcgmrhs (const int *n, double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcgmrhs_get (const int *n, const double *x, const int* nRhs, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl dfgmres_init (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dfgmres_check (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dfgmres (const int *n, double *x, double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dfgmres_get (const int *n, double *x, double *b, int *RCI_request, const int *ipar, const double *dpar, double *tmp, int *itercount); extern void __cdecl DCG_INIT (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCG_CHECK (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCG (const int *n, double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCG_GET (const int *n, const double *x, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl DCGMRHS_INIT (const int *n, const double *x, const int* nRhs, const double *b, const int *method, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCGMRHS_CHECK (const int *n, const double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCGMRHS (const int *n, double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCGMRHS_GET (const int *n, const double *x, const int* nRhs, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl DFGMRES_INIT (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DFGMRES_CHECK (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DFGMRES (const int *n, double *x, double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DFGMRES_GET (const int *n, double *x, double *b, int *RCI_request, const int *ipar, const double *dpar, double *tmp, int *itercount); typedef void* _TRNSP_HANDLE_t; typedef void* _TRNSPBC_HANDLE_t; typedef void* _JACOBIMATRIX_HANDLE_t; typedef void(*USRFCND) (int*,int*,double*,double*); typedef void(*USRFCNXD) (int*,int*,double*,double*,void*); typedef void(*USRFCNS) (int*,int*,float*,float*); typedef void(*USRFCNXS) (int*,int*,float*,float*,void*); extern int __cdecl dtrnlsp_init (_TRNSP_HANDLE_t*, const int*, const int*, const double*, const double*, const int*, const int*, const double*); extern int __cdecl dtrnlsp_check (_TRNSP_HANDLE_t*, const int*, const int*, const double*, const double*, const double*, int*); extern int __cdecl dtrnlsp_solve (_TRNSP_HANDLE_t*, double*, double*, int*); extern int __cdecl dtrnlsp_get (_TRNSP_HANDLE_t*, int*, int*, double*, double*); extern int __cdecl dtrnlsp_delete (_TRNSP_HANDLE_t*); extern int __cdecl dtrnlspbc_init (_TRNSPBC_HANDLE_t*, const int*, const int*, const double*, const double*, const double*, const double*, const int*, const int*, const double*); extern int __cdecl dtrnlspbc_check (_TRNSPBC_HANDLE_t*, const int*, const int*, const double*, const double*, const double*, const double*, const double*, int*); extern int __cdecl dtrnlspbc_solve (_TRNSPBC_HANDLE_t*, double*, double*, int*); extern int __cdecl dtrnlspbc_get (_TRNSPBC_HANDLE_t*, int*, int*, double*, double*); extern int __cdecl dtrnlspbc_delete (_TRNSPBC_HANDLE_t*); extern int __cdecl djacobi_init (_JACOBIMATRIX_HANDLE_t*, const int*, const int*, const double*, const double*, const double*); extern int __cdecl djacobi_solve (_JACOBIMATRIX_HANDLE_t*, double*, double*, int*); extern int __cdecl djacobi_delete (_JACOBIMATRIX_HANDLE_t*); extern int __cdecl djacobi (USRFCND fcn, const int*, const int*, double*, double*, double*); extern int __cdecl djacobix (USRFCNXD fcn, const int*, const int*, double*, double*, double*,void*); extern int __cdecl strnlsp_init (_TRNSP_HANDLE_t*, const int*, const int*, const float*, const float*, const int*, const int*, const float*); extern int __cdecl strnlsp_check (_TRNSP_HANDLE_t*, const int*, const int*, const float*, const float*, const float*, int*); extern int __cdecl strnlsp_solve (_TRNSP_HANDLE_t*, float*, float*, int*); extern int __cdecl strnlsp_get (_TRNSP_HANDLE_t*, int*, int*, float*, float*); extern int __cdecl strnlsp_delete (_TRNSP_HANDLE_t*); extern int __cdecl strnlspbc_init (_TRNSPBC_HANDLE_t*, const int*, const int*, const float*, const float*, const float*, const float*, const int*, const int*, const float*); extern int __cdecl strnlspbc_check (_TRNSPBC_HANDLE_t*, const int*, const int*, const float*, const float*, const float*, const float*, const float*, int*); extern int __cdecl strnlspbc_solve (_TRNSPBC_HANDLE_t*, float*, float*, int*); extern int __cdecl strnlspbc_get (_TRNSPBC_HANDLE_t*, int*, int*, float*, float*); extern int __cdecl strnlspbc_delete (_TRNSPBC_HANDLE_t*); extern int __cdecl sjacobi_init (_JACOBIMATRIX_HANDLE_t*, const int*, const int*, const float*, const float*, const float*); extern int __cdecl sjacobi_solve (_JACOBIMATRIX_HANDLE_t*, float*, float*, int*); extern int __cdecl sjacobi_delete (_JACOBIMATRIX_HANDLE_t*); extern int __cdecl sjacobi (USRFCNS fcn, const int*, const int*, float*, float*, float*); extern int __cdecl sjacobix (USRFCNXS fcn, const int*, const int*, float*, float*, float*,void*); #line 49 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 108 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 168 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 189 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_types.h" typedef struct _DefVmlErrorContext { int iCode; int iIndex; double dbA1; double dbA2; double dbR1; double dbR2; char cFuncName[64]; int iFuncNameLen; double dbA1Im; double dbA2Im; double dbR1Im; double dbR2Im; } DefVmlErrorContext; typedef int (*VMLErrorCallBack) (DefVmlErrorContext* pdefVmlErrorContext); #line 32 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_functions.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_functions.h" extern void __cdecl VSABS (const int *n, const float a[], float r[]); extern void __cdecl VDABS (const int *n, const double a[], double r[]); extern void __cdecl vsabs (const int *n, const float a[], float r[]); extern void __cdecl vdabs (const int *n, const double a[], double r[]); extern void __cdecl vsAbs (const int n, const float a[], float r[]); extern void __cdecl vdAbs (const int n, const double a[], double r[]); extern void __cdecl VMSABS (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDABS (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsabs (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdabs (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAbs (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAbs (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCABS (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl VZABS (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcabs (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzabs (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcAbs (const int n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzAbs (const int n, const MKL_Complex16 a[], double r[]); extern void __cdecl VMCABS (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl VMZABS (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcabs (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl vmzabs (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcAbs (const int n, const MKL_Complex8 a[], float r[], long long int mode); extern void __cdecl vmzAbs (const int n, const MKL_Complex16 a[], double r[], long long int mode); extern void __cdecl VCARG (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl VZARG (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcarg (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzarg (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcArg (const int n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzArg (const int n, const MKL_Complex16 a[], double r[]); extern void __cdecl VMCARG (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl VMZARG (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcarg (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl vmzarg (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcArg (const int n, const MKL_Complex8 a[], float r[], long long int mode); extern void __cdecl vmzArg (const int n, const MKL_Complex16 a[], double r[], long long int mode); extern void __cdecl VSADD (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDADD (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsadd (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdadd (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsAdd (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdAdd (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSADD (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDADD (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsadd (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdadd (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsAdd (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdAdd (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCADD (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZADD (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcadd (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzadd (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcAdd (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzAdd (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCADD (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZADD (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcadd (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzadd (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAdd (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAdd (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSSUB (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDSUB (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vssub (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdsub (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsSub (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdSub (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSSUB (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDSUB (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmssub (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdsub (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsSub (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdSub (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCSUB (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZSUB (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcsub (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzsub (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcSub (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzSub (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCSUB (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSUB (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsub (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsub (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSub (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSub (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSINV (const int *n, const float a[], float r[]); extern void __cdecl VDINV (const int *n, const double a[], double r[]); extern void __cdecl vsinv (const int *n, const float a[], float r[]); extern void __cdecl vdinv (const int *n, const double a[], double r[]); extern void __cdecl vsInv (const int n, const float a[], float r[]); extern void __cdecl vdInv (const int n, const double a[], double r[]); extern void __cdecl VMSINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsinv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdinv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSQRT (const int *n, const float a[], float r[]); extern void __cdecl VDSQRT (const int *n, const double a[], double r[]); extern void __cdecl vssqrt (const int *n, const float a[], float r[]); extern void __cdecl vdsqrt (const int *n, const double a[], double r[]); extern void __cdecl vsSqrt (const int n, const float a[], float r[]); extern void __cdecl vdSqrt (const int n, const double a[], double r[]); extern void __cdecl VMSSQRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSQRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssqrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsqrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSqrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSqrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCSQRT (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZSQRT (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcsqrt (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzsqrt (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcSqrt (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzSqrt (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCSQRT (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSQRT (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsqrt (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsqrt (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSqrt (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSqrt (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSINVSQRT (const int *n, const float a[], float r[]); extern void __cdecl VDINVSQRT (const int *n, const double a[], double r[]); extern void __cdecl vsinvsqrt (const int *n, const float a[], float r[]); extern void __cdecl vdinvsqrt (const int *n, const double a[], double r[]); extern void __cdecl vsInvSqrt (const int n, const float a[], float r[]); extern void __cdecl vdInvSqrt (const int n, const double a[], double r[]); extern void __cdecl VMSINVSQRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDINVSQRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsinvsqrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdinvsqrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsInvSqrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdInvSqrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCBRT (const int *n, const float a[], float r[]); extern void __cdecl VDCBRT (const int *n, const double a[], double r[]); extern void __cdecl vscbrt (const int *n, const float a[], float r[]); extern void __cdecl vdcbrt (const int *n, const double a[], double r[]); extern void __cdecl vsCbrt (const int n, const float a[], float r[]); extern void __cdecl vdCbrt (const int n, const double a[], double r[]); extern void __cdecl VMSCBRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCBRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscbrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcbrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCbrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCbrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSINVCBRT (const int *n, const float a[], float r[]); extern void __cdecl VDINVCBRT (const int *n, const double a[], double r[]); extern void __cdecl vsinvcbrt (const int *n, const float a[], float r[]); extern void __cdecl vdinvcbrt (const int *n, const double a[], double r[]); extern void __cdecl vsInvCbrt (const int n, const float a[], float r[]); extern void __cdecl vdInvCbrt (const int n, const double a[], double r[]); extern void __cdecl VMSINVCBRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDINVCBRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsinvcbrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdinvcbrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsInvCbrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdInvCbrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSQR (const int *n, const float a[], float r[]); extern void __cdecl VDSQR (const int *n, const double a[], double r[]); extern void __cdecl vssqr (const int *n, const float a[], float r[]); extern void __cdecl vdsqr (const int *n, const double a[], double r[]); extern void __cdecl vsSqr (const int n, const float a[], float r[]); extern void __cdecl vdSqr (const int n, const double a[], double r[]); extern void __cdecl VMSSQR (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSQR (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssqr (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsqr (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSqr (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSqr (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSEXP (const int *n, const float a[], float r[]); extern void __cdecl VDEXP (const int *n, const double a[], double r[]); extern void __cdecl vsexp (const int *n, const float a[], float r[]); extern void __cdecl vdexp (const int *n, const double a[], double r[]); extern void __cdecl vsExp (const int n, const float a[], float r[]); extern void __cdecl vdExp (const int n, const double a[], double r[]); extern void __cdecl VMSEXP (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXP (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexp (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexp (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExp (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExp (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCEXP (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZEXP (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcexp (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzexp (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcExp (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzExp (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCEXP (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZEXP (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcexp (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzexp (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcExp (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzExp (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSEXP2 (const int *n, const float a[], float r[]); extern void __cdecl VDEXP2 (const int *n, const double a[], double r[]); extern void __cdecl vsexp2 (const int *n, const float a[], float r[]); extern void __cdecl vdexp2 (const int *n, const double a[], double r[]); extern void __cdecl vsExp2 (const int n, const float a[], float r[]); extern void __cdecl vdExp2 (const int n, const double a[], double r[]); extern void __cdecl VMSEXP2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXP2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexp2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexp2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExp2 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExp2 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSEXP10 (const int *n, const float a[], float r[]); extern void __cdecl VDEXP10 (const int *n, const double a[], double r[]); extern void __cdecl vsexp10 (const int *n, const float a[], float r[]); extern void __cdecl vdexp10 (const int *n, const double a[], double r[]); extern void __cdecl vsExp10 (const int n, const float a[], float r[]); extern void __cdecl vdExp10 (const int n, const double a[], double r[]); extern void __cdecl VMSEXP10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXP10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexp10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexp10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExp10 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExp10 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSEXPM1 (const int *n, const float a[], float r[]); extern void __cdecl VDEXPM1 (const int *n, const double a[], double r[]); extern void __cdecl vsexpm1 (const int *n, const float a[], float r[]); extern void __cdecl vdexpm1 (const int *n, const double a[], double r[]); extern void __cdecl vsExpm1 (const int n, const float a[], float r[]); extern void __cdecl vdExpm1 (const int n, const double a[], double r[]); extern void __cdecl VMSEXPM1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXPM1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexpm1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexpm1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExpm1 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExpm1 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLN (const int *n, const float a[], float r[]); extern void __cdecl VDLN (const int *n, const double a[], double r[]); extern void __cdecl vsln (const int *n, const float a[], float r[]); extern void __cdecl vdln (const int *n, const double a[], double r[]); extern void __cdecl vsLn (const int n, const float a[], float r[]); extern void __cdecl vdLn (const int n, const double a[], double r[]); extern void __cdecl VMSLN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsln (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdln (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLn (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLn (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCLN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZLN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcln (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzln (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcLn (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzLn (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCLN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZLN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcln (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzln (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcLn (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzLn (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSLOG2 (const int *n, const float a[], float r[]); extern void __cdecl VDLOG2 (const int *n, const double a[], double r[]); extern void __cdecl vslog2 (const int *n, const float a[], float r[]); extern void __cdecl vdlog2 (const int *n, const double a[], double r[]); extern void __cdecl vsLog2 (const int n, const float a[], float r[]); extern void __cdecl vdLog2 (const int n, const double a[], double r[]); extern void __cdecl VMSLOG2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOG2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslog2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlog2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLog2 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLog2 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLOG10 (const int *n, const float a[], float r[]); extern void __cdecl VDLOG10 (const int *n, const double a[], double r[]); extern void __cdecl vslog10 (const int *n, const float a[], float r[]); extern void __cdecl vdlog10 (const int *n, const double a[], double r[]); extern void __cdecl vsLog10 (const int n, const float a[], float r[]); extern void __cdecl vdLog10 (const int n, const double a[], double r[]); extern void __cdecl VMSLOG10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOG10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslog10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlog10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLog10 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLog10 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCLOG10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZLOG10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vclog10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzlog10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcLog10 (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzLog10 (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCLOG10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZLOG10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmclog10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzlog10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcLog10 (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzLog10 (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSLOG1P (const int *n, const float a[], float r[]); extern void __cdecl VDLOG1P (const int *n, const double a[], double r[]); extern void __cdecl vslog1p (const int *n, const float a[], float r[]); extern void __cdecl vdlog1p (const int *n, const double a[], double r[]); extern void __cdecl vsLog1p (const int n, const float a[], float r[]); extern void __cdecl vdLog1p (const int n, const double a[], double r[]); extern void __cdecl VMSLOG1P (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOG1P (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslog1p (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlog1p (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLog1p (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLog1p (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLOGB (const int *n, const float a[], float r[]); extern void __cdecl VDLOGB (const int *n, const double a[], double r[]); extern void __cdecl vslogb (const int *n, const float a[], float r[]); extern void __cdecl vdlogb (const int *n, const double a[], double r[]); extern void __cdecl vsLogb (const int n, const float a[], float r[]); extern void __cdecl vdLogb (const int n, const double a[], double r[]); extern void __cdecl VMSLOGB (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOGB (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslogb (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlogb (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLogb (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLogb (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCOS (const int *n, const float a[], float r[]); extern void __cdecl VDCOS (const int *n, const double a[], double r[]); extern void __cdecl vscos (const int *n, const float a[], float r[]); extern void __cdecl vdcos (const int *n, const double a[], double r[]); extern void __cdecl vsCos (const int n, const float a[], float r[]); extern void __cdecl vdCos (const int n, const double a[], double r[]); extern void __cdecl VMSCOS (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCOS (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscos (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcos (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCos (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCos (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCCOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZCOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vccos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzcos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcCos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzCos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCCOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmccos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzcos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcCos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzCos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSSIN (const int *n, const float a[], float r[]); extern void __cdecl VDSIN (const int *n, const double a[], double r[]); extern void __cdecl vssin (const int *n, const float a[], float r[]); extern void __cdecl vdsin (const int *n, const double a[], double r[]); extern void __cdecl vsSin (const int n, const float a[], float r[]); extern void __cdecl vdSin (const int n, const double a[], double r[]); extern void __cdecl VMSSIN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSIN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssin (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsin (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSin (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSin (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCSIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZSIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcsin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzsin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcSin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzSin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCSIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSTAN (const int *n, const float a[], float r[]); extern void __cdecl VDTAN (const int *n, const double a[], double r[]); extern void __cdecl vstan (const int *n, const float a[], float r[]); extern void __cdecl vdtan (const int *n, const double a[], double r[]); extern void __cdecl vsTan (const int n, const float a[], float r[]); extern void __cdecl vdTan (const int n, const double a[], double r[]); extern void __cdecl VMSTAN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTAN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstan (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtan (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTan (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTan (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCTAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZTAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vctan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vztan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcTan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzTan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCTAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZTAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmctan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmztan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcTan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzTan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSCOSPI (const int *n, const float a[], float r[]); extern void __cdecl VDCOSPI (const int *n, const double a[], double r[]); extern void __cdecl vscospi (const int *n, const float a[], float r[]); extern void __cdecl vdcospi (const int *n, const double a[], double r[]); extern void __cdecl vsCospi (const int n, const float a[], float r[]); extern void __cdecl vdCospi (const int n, const double a[], double r[]); extern void __cdecl VMSCOSPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscospi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCospi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCospi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSINPI (const int *n, const float a[], float r[]); extern void __cdecl VDSINPI (const int *n, const double a[], double r[]); extern void __cdecl vssinpi (const int *n, const float a[], float r[]); extern void __cdecl vdsinpi (const int *n, const double a[], double r[]); extern void __cdecl vsSinpi (const int n, const float a[], float r[]); extern void __cdecl vdSinpi (const int n, const double a[], double r[]); extern void __cdecl VMSSINPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssinpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSinpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSinpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTANPI (const int *n, const float a[], float r[]); extern void __cdecl VDTANPI (const int *n, const double a[], double r[]); extern void __cdecl vstanpi (const int *n, const float a[], float r[]); extern void __cdecl vdtanpi (const int *n, const double a[], double r[]); extern void __cdecl vsTanpi (const int n, const float a[], float r[]); extern void __cdecl vdTanpi (const int n, const double a[], double r[]); extern void __cdecl VMSTANPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstanpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTanpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTanpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCOSD (const int *n, const float a[], float r[]); extern void __cdecl VDCOSD (const int *n, const double a[], double r[]); extern void __cdecl vscosd (const int *n, const float a[], float r[]); extern void __cdecl vdcosd (const int *n, const double a[], double r[]); extern void __cdecl vsCosd (const int n, const float a[], float r[]); extern void __cdecl vdCosd (const int n, const double a[], double r[]); extern void __cdecl VMSCOSD (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCosd (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscosd (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcosd (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCosd (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCosd (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSIND (const int *n, const float a[], float r[]); extern void __cdecl VDSIND (const int *n, const double a[], double r[]); extern void __cdecl vssind (const int *n, const float a[], float r[]); extern void __cdecl vdsind (const int *n, const double a[], double r[]); extern void __cdecl vsSind (const int n, const float a[], float r[]); extern void __cdecl vdSind (const int n, const double a[], double r[]); extern void __cdecl VMSSIND (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSind (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssind (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsind (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSind (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSind (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTAND (const int *n, const float a[], float r[]); extern void __cdecl VDTAND (const int *n, const double a[], double r[]); extern void __cdecl vstand (const int *n, const float a[], float r[]); extern void __cdecl vdtand (const int *n, const double a[], double r[]); extern void __cdecl vsTand (const int n, const float a[], float r[]); extern void __cdecl vdTand (const int n, const double a[], double r[]); extern void __cdecl VMSTAND (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTand (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstand (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtand (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTand (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTand (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCOSH (const int *n, const float a[], float r[]); extern void __cdecl VDCOSH (const int *n, const double a[], double r[]); extern void __cdecl vscosh (const int *n, const float a[], float r[]); extern void __cdecl vdcosh (const int *n, const double a[], double r[]); extern void __cdecl vsCosh (const int n, const float a[], float r[]); extern void __cdecl vdCosh (const int n, const double a[], double r[]); extern void __cdecl VMSCOSH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCOSH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscosh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcosh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCosh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCosh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCCOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZCOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vccosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzcosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcCosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzCosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCCOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmccosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzcosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcCosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzCosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSSINH (const int *n, const float a[], float r[]); extern void __cdecl VDSINH (const int *n, const double a[], double r[]); extern void __cdecl vssinh (const int *n, const float a[], float r[]); extern void __cdecl vdsinh (const int *n, const double a[], double r[]); extern void __cdecl vsSinh (const int n, const float a[], float r[]); extern void __cdecl vdSinh (const int n, const double a[], double r[]); extern void __cdecl VMSSINH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSINH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssinh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsinh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSinh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSinh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCSINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZSINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcsinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzsinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcSinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzSinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCSINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSTANH (const int *n, const float a[], float r[]); extern void __cdecl VDTANH (const int *n, const double a[], double r[]); extern void __cdecl vstanh (const int *n, const float a[], float r[]); extern void __cdecl vdtanh (const int *n, const double a[], double r[]); extern void __cdecl vsTanh (const int n, const float a[], float r[]); extern void __cdecl vdTanh (const int n, const double a[], double r[]); extern void __cdecl VMSTANH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTANH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstanh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtanh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTanh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTanh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCTANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZTANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vctanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vztanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcTanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzTanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCTANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZTANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmctanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmztanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcTanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzTanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSACOS (const int *n, const float a[], float r[]); extern void __cdecl VDACOS (const int *n, const double a[], double r[]); extern void __cdecl vsacos (const int *n, const float a[], float r[]); extern void __cdecl vdacos (const int *n, const double a[], double r[]); extern void __cdecl vsAcos (const int n, const float a[], float r[]); extern void __cdecl vdAcos (const int n, const double a[], double r[]); extern void __cdecl VMSACOS (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDACOS (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsacos (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdacos (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAcos (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAcos (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCACOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZACOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcacos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzacos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAcos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAcos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCACOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZACOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcacos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzacos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAcos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAcos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSASIN (const int *n, const float a[], float r[]); extern void __cdecl VDASIN (const int *n, const double a[], double r[]); extern void __cdecl vsasin (const int *n, const float a[], float r[]); extern void __cdecl vdasin (const int *n, const double a[], double r[]); extern void __cdecl vsAsin (const int n, const float a[], float r[]); extern void __cdecl vdAsin (const int n, const double a[], double r[]); extern void __cdecl VMSASIN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDASIN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsasin (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdasin (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAsin (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAsin (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCASIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZASIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcasin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzasin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAsin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAsin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCASIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZASIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcasin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzasin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAsin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAsin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSATAN (const int *n, const float a[], float r[]); extern void __cdecl VDATAN (const int *n, const double a[], double r[]); extern void __cdecl vsatan (const int *n, const float a[], float r[]); extern void __cdecl vdatan (const int *n, const double a[], double r[]); extern void __cdecl vsAtan (const int n, const float a[], float r[]); extern void __cdecl vdAtan (const int n, const double a[], double r[]); extern void __cdecl VMSATAN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDATAN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsatan (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdatan (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAtan (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAtan (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCATAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZATAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcatan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzatan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAtan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAtan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCATAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZATAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcatan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzatan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAtan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAtan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSACOSPI (const int *n, const float a[], float r[]); extern void __cdecl VDACOSPI (const int *n, const double a[], double r[]); extern void __cdecl vsacospi (const int *n, const float a[], float r[]); extern void __cdecl vdacospi (const int *n, const double a[], double r[]); extern void __cdecl vsAcospi (const int n, const float a[], float r[]); extern void __cdecl vdAcospi (const int n, const double a[], double r[]); extern void __cdecl VMSACOSPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDAcospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsacospi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdacospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAcospi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAcospi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSASINPI (const int *n, const float a[], float r[]); extern void __cdecl VDASINPI (const int *n, const double a[], double r[]); extern void __cdecl vsasinpi (const int *n, const float a[], float r[]); extern void __cdecl vdasinpi (const int *n, const double a[], double r[]); extern void __cdecl vsAsinpi (const int n, const float a[], float r[]); extern void __cdecl vdAsinpi (const int n, const double a[], double r[]); extern void __cdecl VMSASINPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDAsinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsasinpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdasinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAsinpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAsinpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSATANPI (const int *n, const float a[], float r[]); extern void __cdecl VDATANPI (const int *n, const double a[], double r[]); extern void __cdecl vsatanpi (const int *n, const float a[], float r[]); extern void __cdecl vdatanpi (const int *n, const double a[], double r[]); extern void __cdecl vsAtanpi (const int n, const float a[], float r[]); extern void __cdecl vdAtanpi (const int n, const double a[], double r[]); extern void __cdecl VMSATANPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDAtanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsatanpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdatanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAtanpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAtanpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSACOSH (const int *n, const float a[], float r[]); extern void __cdecl VDACOSH (const int *n, const double a[], double r[]); extern void __cdecl vsacosh (const int *n, const float a[], float r[]); extern void __cdecl vdacosh (const int *n, const double a[], double r[]); extern void __cdecl vsAcosh (const int n, const float a[], float r[]); extern void __cdecl vdAcosh (const int n, const double a[], double r[]); extern void __cdecl VMSACOSH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDACOSH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsacosh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdacosh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAcosh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAcosh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCACOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZACOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcacosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzacosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAcosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAcosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCACOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZACOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcacosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzacosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAcosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAcosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSASINH (const int *n, const float a[], float r[]); extern void __cdecl VDASINH (const int *n, const double a[], double r[]); extern void __cdecl vsasinh (const int *n, const float a[], float r[]); extern void __cdecl vdasinh (const int *n, const double a[], double r[]); extern void __cdecl vsAsinh (const int n, const float a[], float r[]); extern void __cdecl vdAsinh (const int n, const double a[], double r[]); extern void __cdecl VMSASINH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDASINH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsasinh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdasinh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAsinh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAsinh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCASINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZASINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcasinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzasinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAsinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAsinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCASINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZASINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcasinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzasinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAsinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAsinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSATANH (const int *n, const float a[], float r[]); extern void __cdecl VDATANH (const int *n, const double a[], double r[]); extern void __cdecl vsatanh (const int *n, const float a[], float r[]); extern void __cdecl vdatanh (const int *n, const double a[], double r[]); extern void __cdecl vsAtanh (const int n, const float a[], float r[]); extern void __cdecl vdAtanh (const int n, const double a[], double r[]); extern void __cdecl VMSATANH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDATANH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsatanh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdatanh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAtanh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAtanh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCATANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZATANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcatanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzatanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAtanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAtanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCATANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZATANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcatanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzatanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAtanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAtanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSERF (const int *n, const float a[], float r[]); extern void __cdecl VDERF (const int *n, const double a[], double r[]); extern void __cdecl vserf (const int *n, const float a[], float r[]); extern void __cdecl vderf (const int *n, const double a[], double r[]); extern void __cdecl vsErf (const int n, const float a[], float r[]); extern void __cdecl vdErf (const int n, const double a[], double r[]); extern void __cdecl VMSERF (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERF (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserf (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderf (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErf (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErf (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSERFINV (const int *n, const float a[], float r[]); extern void __cdecl VDERFINV (const int *n, const double a[], double r[]); extern void __cdecl vserfinv (const int *n, const float a[], float r[]); extern void __cdecl vderfinv (const int *n, const double a[], double r[]); extern void __cdecl vsErfInv (const int n, const float a[], float r[]); extern void __cdecl vdErfInv (const int n, const double a[], double r[]); extern void __cdecl VMSERFINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERFINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserfinv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderfinv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErfInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErfInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSHYPOT (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDHYPOT (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vshypot (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdhypot (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsHypot (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdHypot (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSHYPOT (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDHYPOT (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmshypot (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdhypot (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsHypot (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdHypot (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSERFC (const int *n, const float a[], float r[]); extern void __cdecl VDERFC (const int *n, const double a[], double r[]); extern void __cdecl vserfc (const int *n, const float a[], float r[]); extern void __cdecl vderfc (const int *n, const double a[], double r[]); extern void __cdecl vsErfc (const int n, const float a[], float r[]); extern void __cdecl vdErfc (const int n, const double a[], double r[]); extern void __cdecl VMSERFC (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERFC (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserfc (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderfc (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErfc (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErfc (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSERFCINV (const int *n, const float a[], float r[]); extern void __cdecl VDERFCINV (const int *n, const double a[], double r[]); extern void __cdecl vserfcinv (const int *n, const float a[], float r[]); extern void __cdecl vderfcinv (const int *n, const double a[], double r[]); extern void __cdecl vsErfcInv (const int n, const float a[], float r[]); extern void __cdecl vdErfcInv (const int n, const double a[], double r[]); extern void __cdecl VMSERFCINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERFCINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserfcinv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderfcinv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErfcInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErfcInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCDFNORM (const int *n, const float a[], float r[]); extern void __cdecl VDCDFNORM (const int *n, const double a[], double r[]); extern void __cdecl vscdfnorm (const int *n, const float a[], float r[]); extern void __cdecl vdcdfnorm (const int *n, const double a[], double r[]); extern void __cdecl vsCdfNorm (const int n, const float a[], float r[]); extern void __cdecl vdCdfNorm (const int n, const double a[], double r[]); extern void __cdecl VMSCDFNORM (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCDFNORM (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscdfnorm (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcdfnorm (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCdfNorm (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCdfNorm (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCDFNORMINV (const int *n, const float a[], float r[]); extern void __cdecl VDCDFNORMINV (const int *n, const double a[], double r[]); extern void __cdecl vscdfnorminv (const int *n, const float a[], float r[]); extern void __cdecl vdcdfnorminv (const int *n, const double a[], double r[]); extern void __cdecl vsCdfNormInv (const int n, const float a[], float r[]); extern void __cdecl vdCdfNormInv (const int n, const double a[], double r[]); extern void __cdecl VMSCDFNORMINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCDFNORMINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscdfnorminv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcdfnorminv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCdfNormInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCdfNormInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLGAMMA (const int *n, const float a[], float r[]); extern void __cdecl VDLGAMMA (const int *n, const double a[], double r[]); extern void __cdecl vslgamma (const int *n, const float a[], float r[]); extern void __cdecl vdlgamma (const int *n, const double a[], double r[]); extern void __cdecl vsLGamma (const int n, const float a[], float r[]); extern void __cdecl vdLGamma (const int n, const double a[], double r[]); extern void __cdecl VMSLGAMMA (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLGAMMA (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslgamma (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlgamma (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLGamma (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLGamma (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTGAMMA (const int *n, const float a[], float r[]); extern void __cdecl VDTGAMMA (const int *n, const double a[], double r[]); extern void __cdecl vstgamma (const int *n, const float a[], float r[]); extern void __cdecl vdtgamma (const int *n, const double a[], double r[]); extern void __cdecl vsTGamma (const int n, const float a[], float r[]); extern void __cdecl vdTGamma (const int n, const double a[], double r[]); extern void __cdecl VMSTGAMMA (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTGAMMA (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstgamma (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtgamma (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTGamma (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTGamma (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSATAN2 (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDATAN2 (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsatan2 (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdatan2 (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsAtan2 (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdAtan2 (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSATAN2 (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDATAN2 (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsatan2 (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdatan2 (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsAtan2 (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdAtan2 (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSATAN2PI (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDATAN2PI (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsatan2pi (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdatan2pi (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsAtan2pi (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdAtan2pi (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSATAN2PI (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDATAN2PI (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsatan2pi (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdatan2pi (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsAtan2pi (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdAtan2pi (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSMUL (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDMUL (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsmul (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdmul (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsMul (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdMul (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSMUL (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDMUL (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsmul (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdmul (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsMul (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdMul (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCMUL (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZMUL (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcmul (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzmul (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcMul (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzMul (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCMUL (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZMUL (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcmul (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzmul (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcMul (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzMul (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSDIV (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDDIV (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsdiv (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vddiv (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsDiv (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdDiv (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSDIV (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDDIV (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsdiv (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmddiv (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsDiv (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdDiv (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCDIV (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZDIV (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcdiv (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzdiv (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcDiv (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzDiv (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCDIV (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZDIV (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcdiv (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzdiv (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcDiv (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzDiv (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSPOW (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDPOW (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vspow (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdpow (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsPow (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdPow (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSPOW (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDPOW (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmspow (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdpow (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsPow (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdPow (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCPOW (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZPOW (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcpow (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzpow (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcPow (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzPow (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCPOW (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZPOW (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcpow (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzpow (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcPow (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzPow (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSPOW3O2 (const int *n, const float a[], float r[]); extern void __cdecl VDPOW3O2 (const int *n, const double a[], double r[]); extern void __cdecl vspow3o2 (const int *n, const float a[], float r[]); extern void __cdecl vdpow3o2 (const int *n, const double a[], double r[]); extern void __cdecl vsPow3o2 (const int n, const float a[], float r[]); extern void __cdecl vdPow3o2 (const int n, const double a[], double r[]); extern void __cdecl VMSPOW3O2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDPOW3O2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmspow3o2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdpow3o2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsPow3o2 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdPow3o2 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSPOW2O3 (const int *n, const float a[], float r[]); extern void __cdecl VDPOW2O3 (const int *n, const double a[], double r[]); extern void __cdecl vspow2o3 (const int *n, const float a[], float r[]); extern void __cdecl vdpow2o3 (const int *n, const double a[], double r[]); extern void __cdecl vsPow2o3 (const int n, const float a[], float r[]); extern void __cdecl vdPow2o3 (const int n, const double a[], double r[]); extern void __cdecl VMSPOW2O3 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDPOW2O3 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmspow2o3 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdpow2o3 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsPow2o3 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdPow2o3 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSPOWX (const int *n, const float a[], const float *b, float r[]); extern void __cdecl VDPOWX (const int *n, const double a[], const double *b, double r[]); extern void __cdecl vspowx (const int *n, const float a[], const float *b, float r[]); extern void __cdecl vdpowx (const int *n, const double a[], const double *b, double r[]); extern void __cdecl vsPowx (const int n, const float a[], const float b, float r[]); extern void __cdecl vdPowx (const int n, const double a[], const double b, double r[]); extern void __cdecl VMSPOWX (const int *n, const float a[], const float *b, float r[], long long int *mode); extern void __cdecl VMDPOWX (const int *n, const double a[], const double *b, double r[], long long int *mode); extern void __cdecl vmspowx (const int *n, const float a[], const float *b, float r[], long long int *mode); extern void __cdecl vmdpowx (const int *n, const double a[], const double *b, double r[], long long int *mode); extern void __cdecl vmsPowx (const int n, const float a[], const float b, float r[], long long int mode); extern void __cdecl vmdPowx (const int n, const double a[], const double b, double r[], long long int mode); extern void __cdecl VCPOWX (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[]); extern void __cdecl VZPOWX (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[]); extern void __cdecl vcpowx (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[]); extern void __cdecl vzpowx (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[]); extern void __cdecl vcPowx (const int n, const MKL_Complex8 a[], const MKL_Complex8 b, MKL_Complex8 r[]); extern void __cdecl vzPowx (const int n, const MKL_Complex16 a[], const MKL_Complex16 b, MKL_Complex16 r[]); extern void __cdecl VMCPOWX (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZPOWX (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcpowx (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzpowx (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcPowx (const int n, const MKL_Complex8 a[], const MKL_Complex8 b, MKL_Complex8 r[], long long int mode); extern void __cdecl vmzPowx (const int n, const MKL_Complex16 a[], const MKL_Complex16 b, MKL_Complex16 r[], long long int mode); extern void __cdecl VSPOWR (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDPOWR (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vspowr (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdpowr (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsPowr (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdPowr (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSPOWR (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDPOWR (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmspowr (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdpowr (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsPowr (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdPowr (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSSINCOS (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDSINCOS (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vssincos (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdsincos (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsSinCos (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdSinCos (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSSINCOS (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDSINCOS (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmssincos (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdsincos (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsSinCos (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdSinCos (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSLINEARFRAC (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[]); extern void __cdecl VDLINEARFRAC (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[]); extern void __cdecl vslinearfrac (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[]); extern void __cdecl vdlinearfrac (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[]); extern void __cdecl vsLinearFrac (const int n, const float a[], const float b[], const float scalea, const float shifta, const float scaleb, const float shiftb, float r[]); extern void __cdecl vdLinearFrac (const int n, const double a[], const double b[], const double scalea, const double shifta, const double scaleb, const double shiftb, double r[]); extern void __cdecl VMSLINEARFRAC (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[], long long int *mode); extern void __cdecl VMDLINEARFRAC (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[], long long int *mode); extern void __cdecl vmslinearfrac (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[], long long int *mode); extern void __cdecl vmdlinearfrac (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[], long long int *mode); extern void __cdecl vmsLinearFrac (const int n, const float a[], const float b[], const float scalea, const float shifta, const float scaleb, const float shiftb, float r[], long long int mode); extern void __cdecl vmdLinearFrac (const int n, const double a[], const double b[], const double scalea, const double shifta, const double scaleb, const double shiftb, double r[], long long int mode); extern void __cdecl VSCEIL (const int *n, const float a[], float r[]); extern void __cdecl VDCEIL (const int *n, const double a[], double r[]); extern void __cdecl vsceil (const int *n, const float a[], float r[]); extern void __cdecl vdceil (const int *n, const double a[], double r[]); extern void __cdecl vsCeil (const int n, const float a[], float r[]); extern void __cdecl vdCeil (const int n, const double a[], double r[]); extern void __cdecl VMSCEIL (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCEIL (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsceil (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdceil (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCeil (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCeil (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSFLOOR (const int *n, const float a[], float r[]); extern void __cdecl VDFLOOR (const int *n, const double a[], double r[]); extern void __cdecl vsfloor (const int *n, const float a[], float r[]); extern void __cdecl vdfloor (const int *n, const double a[], double r[]); extern void __cdecl vsFloor (const int n, const float a[], float r[]); extern void __cdecl vdFloor (const int n, const double a[], double r[]); extern void __cdecl VMSFLOOR (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDFLOOR (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsfloor (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdfloor (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsFloor (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdFloor (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSFRAC (const int *n, const float a[], float r[]); extern void __cdecl VDFRAC (const int *n, const double a[], double r[]); extern void __cdecl vsfrac (const int *n, const float a[], float r[]); extern void __cdecl vdfrac (const int *n, const double a[], double r[]); extern void __cdecl vsFrac (const int n, const float a[], float r[]); extern void __cdecl vdFrac (const int n, const double a[], double r[]); extern void __cdecl VMSFRAC (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDFRAC (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsfrac (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdfrac (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsFrac (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdFrac (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSMODF (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDMODF (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsmodf (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdmodf (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsModf (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdModf (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSMODF (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDMODF (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsmodf (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdmodf (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsModf (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdModf (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFMOD (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFMOD (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfmod (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfmod (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFmod (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFmod (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFMOD (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFMOD (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfmod (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfmod (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFmod (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFmod (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSREMAINDER (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDREMAINDER (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsremainder (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdremainder (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsRemainder (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdRemainder (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSREMAINDER (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDREMAINDER (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsremainder (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdremainder (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsRemainder (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdRemainder (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSNEXTAFTER (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDNEXTAFTER (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsnextafter (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdnextafter (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsNextAfter (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdNextAfter (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSNEXTAFTER (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDNEXTAFTER (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsnextafter (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdnextafter (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsNextAfter (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdNextAfter (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSCOPYSIGN (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDCOPYSIGN (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vscopysign (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdcopysign (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsCopySign (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdCopySign (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSCOPYSIGN (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDCOPYSIGN (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmscopysign (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdcopysign (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsCopySign (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdCopySign (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFDIM (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFDIM (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfdim (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfdim (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFdim (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFdim (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFDIM (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFDIM (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfdim (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfdim (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFdim (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFdim (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFMAX (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFMAX (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfmax (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfmax (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFmax (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFmax (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFMAX (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFMAX (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfmax (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfmax (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFmax (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFmax (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFMIN (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFMIN (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfmin (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfmin (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFmin (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFmin (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFMIN (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFMIN (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfmin (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfmin (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFmin (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFmin (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSMAXMAG (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDMAXMAG (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsmaxmag (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdmaxmag (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsMaxMag (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdMaxMag (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSMAXMAG (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDMAXMAG (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsmaxmag (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdmaxmag (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsMaxMag (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdMaxMag (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSMINMAG (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDMINMAG (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsminmag (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdminmag (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsMinMag (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdMinMag (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSMINMAG (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDMINMAG (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsminmag (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdminmag (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsMinMag (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdMinMag (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSNEARBYINT (const int *n, const float a[], float r[]); extern void __cdecl VDNEARBYINT (const int *n, const double a[], double r[]); extern void __cdecl vsnearbyint (const int *n, const float a[], float r[]); extern void __cdecl vdnearbyint (const int *n, const double a[], double r[]); extern void __cdecl vsNearbyInt (const int n, const float a[], float r[]); extern void __cdecl vdNearbyInt (const int n, const double a[], double r[]); extern void __cdecl VMSNEARBYINT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDNEARBYINT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsnearbyint (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdnearbyint (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsNearbyInt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdNearbyInt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSRINT (const int *n, const float a[], float r[]); extern void __cdecl VDRINT (const int *n, const double a[], double r[]); extern void __cdecl vsrint (const int *n, const float a[], float r[]); extern void __cdecl vdrint (const int *n, const double a[], double r[]); extern void __cdecl vsRint (const int n, const float a[], float r[]); extern void __cdecl vdRint (const int n, const double a[], double r[]); extern void __cdecl VMSRINT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDRINT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsrint (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdrint (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsRint (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdRint (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSROUND (const int *n, const float a[], float r[]); extern void __cdecl VDROUND (const int *n, const double a[], double r[]); extern void __cdecl vsround (const int *n, const float a[], float r[]); extern void __cdecl vdround (const int *n, const double a[], double r[]); extern void __cdecl vsRound (const int n, const float a[], float r[]); extern void __cdecl vdRound (const int n, const double a[], double r[]); extern void __cdecl VMSROUND (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDROUND (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsround (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdround (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsRound (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdRound (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTRUNC (const int *n, const float a[], float r[]); extern void __cdecl VDTRUNC (const int *n, const double a[], double r[]); extern void __cdecl vstrunc (const int *n, const float a[], float r[]); extern void __cdecl vdtrunc (const int *n, const double a[], double r[]); extern void __cdecl vsTrunc (const int n, const float a[], float r[]); extern void __cdecl vdTrunc (const int n, const double a[], double r[]); extern void __cdecl VMSTRUNC (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTRUNC (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstrunc (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtrunc (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTrunc (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTrunc (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCCONJ (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZCONJ (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcconj (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzconj (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcConj (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzConj (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCCONJ (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCONJ (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcconj (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzconj (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcConj (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzConj (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VCMULBYCONJ (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZMULBYCONJ (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcmulbyconj (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzmulbyconj (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcMulByConj (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzMulByConj (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCMULBYCONJ (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZMULBYCONJ (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcmulbyconj (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzmulbyconj (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcMulByConj (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzMulByConj (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VCCIS (const int *n, const float a[], MKL_Complex8 r[]); extern void __cdecl VZCIS (const int *n, const double a[], MKL_Complex16 r[]); extern void __cdecl vccis (const int *n, const float a[], MKL_Complex8 r[]); extern void __cdecl vzcis (const int *n, const double a[], MKL_Complex16 r[]); extern void __cdecl vcCIS (const int n, const float a[], MKL_Complex8 r[]); extern void __cdecl vzCIS (const int n, const double a[], MKL_Complex16 r[]); extern void __cdecl VMCCIS (const int *n, const float a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCIS (const int *n, const double a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmccis (const int *n, const float a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzcis (const int *n, const double a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcCIS (const int n, const float a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzCIS (const int n, const double a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSEXPINT1 (const int *n, const float a[], float r[]); extern void __cdecl VDEXPINT1 (const int *n, const double a[], double r[]); extern void __cdecl vsexpint1 (const int *n, const float a[], float r[]); extern void __cdecl vdexpint1 (const int *n, const double a[], double r[]); extern void __cdecl vsExpInt1 (const int n, const float a[], float r[]); extern void __cdecl vdExpInt1 (const int n, const double a[], double r[]); extern void __cdecl VMSEXPINT1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXPINT1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexpint1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexpint1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExpInt1 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExpInt1 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSPACKI (const int *n, const float a[], const int * incra, float y[]); extern void __cdecl VDPACKI (const int *n, const double a[], const int * incra, double y[]); extern void __cdecl vspacki (const int *n, const float a[], const int * incra, float y[]); extern void __cdecl vdpacki (const int *n, const double a[], const int * incra, double y[]); extern void __cdecl vsPackI (const int n, const float a[], const int incra, float y[]); extern void __cdecl vdPackI (const int n, const double a[], const int incra, double y[]); extern void __cdecl VCPACKI (const int *n, const MKL_Complex8 a[], const int * incra, MKL_Complex8 y[]); extern void __cdecl VZPACKI (const int *n, const MKL_Complex16 a[], const int * incra, MKL_Complex16 y[]); extern void __cdecl vcpacki (const int *n, const MKL_Complex8 a[], const int * incra, MKL_Complex8 y[]); extern void __cdecl vzpacki (const int *n, const MKL_Complex16 a[], const int * incra, MKL_Complex16 y[]); extern void __cdecl vcPackI (const int n, const MKL_Complex8 a[], const int incra, MKL_Complex8 y[]); extern void __cdecl vzPackI (const int n, const MKL_Complex16 a[], const int incra, MKL_Complex16 y[]); extern void __cdecl VSPACKV (const int *n, const float a[], const int ia[], float y[]); extern void __cdecl VDPACKV (const int *n, const double a[], const int ia[], double y[]); extern void __cdecl vspackv (const int *n, const float a[], const int ia[], float y[]); extern void __cdecl vdpackv (const int *n, const double a[], const int ia[], double y[]); extern void __cdecl vsPackV (const int n, const float a[], const int ia[], float y[]); extern void __cdecl vdPackV (const int n, const double a[], const int ia[], double y[]); extern void __cdecl VCPACKV (const int *n, const MKL_Complex8 a[], const int ia[], MKL_Complex8 y[]); extern void __cdecl VZPACKV (const int *n, const MKL_Complex16 a[], const int ia[], MKL_Complex16 y[]); extern void __cdecl vcpackv (const int *n, const MKL_Complex8 a[], const int ia[], MKL_Complex8 y[]); extern void __cdecl vzpackv (const int *n, const MKL_Complex16 a[], const int ia[], MKL_Complex16 y[]); extern void __cdecl vcPackV (const int n, const MKL_Complex8 a[], const int ia[], MKL_Complex8 y[]); extern void __cdecl vzPackV (const int n, const MKL_Complex16 a[], const int ia[], MKL_Complex16 y[]); extern void __cdecl VSPACKM (const int *n, const float a[], const int ma[], float y[]); extern void __cdecl VDPACKM (const int *n, const double a[], const int ma[], double y[]); extern void __cdecl vspackm (const int *n, const float a[], const int ma[], float y[]); extern void __cdecl vdpackm (const int *n, const double a[], const int ma[], double y[]); extern void __cdecl vsPackM (const int n, const float a[], const int ma[], float y[]); extern void __cdecl vdPackM (const int n, const double a[], const int ma[], double y[]); extern void __cdecl VCPACKM (const int *n, const MKL_Complex8 a[], const int ma[], MKL_Complex8 y[]); extern void __cdecl VZPACKM (const int *n, const MKL_Complex16 a[], const int ma[], MKL_Complex16 y[]); extern void __cdecl vcpackm (const int *n, const MKL_Complex8 a[], const int ma[], MKL_Complex8 y[]); extern void __cdecl vzpackm (const int *n, const MKL_Complex16 a[], const int ma[], MKL_Complex16 y[]); extern void __cdecl vcPackM (const int n, const MKL_Complex8 a[], const int ma[], MKL_Complex8 y[]); extern void __cdecl vzPackM (const int n, const MKL_Complex16 a[], const int ma[], MKL_Complex16 y[]); extern void __cdecl VSUNPACKI (const int *n, const float a[], float y[], const int * incry); extern void __cdecl VDUNPACKI (const int *n, const double a[], double y[], const int * incry); extern void __cdecl vsunpacki (const int *n, const float a[], float y[], const int * incry); extern void __cdecl vdunpacki (const int *n, const double a[], double y[], const int * incry); extern void __cdecl vsUnpackI (const int n, const float a[], float y[], const int incry ); extern void __cdecl vdUnpackI (const int n, const double a[], double y[], const int incry ); extern void __cdecl VCUNPACKI (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int * incry); extern void __cdecl VZUNPACKI (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int * incry); extern void __cdecl vcunpacki (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int * incry); extern void __cdecl vzunpacki (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int * incry); extern void __cdecl vcUnpackI (const int n, const MKL_Complex8 a[], MKL_Complex8 y[], const int incry ); extern void __cdecl vzUnpackI (const int n, const MKL_Complex16 a[], MKL_Complex16 y[], const int incry ); extern void __cdecl VSUNPACKV (const int *n, const float a[], float y[], const int iy[] ); extern void __cdecl VDUNPACKV (const int *n, const double a[], double y[], const int iy[] ); extern void __cdecl vsunpackv (const int *n, const float a[], float y[], const int iy[] ); extern void __cdecl vdunpackv (const int *n, const double a[], double y[], const int iy[] ); extern void __cdecl vsUnpackV (const int n, const float a[], float y[], const int iy[] ); extern void __cdecl vdUnpackV (const int n, const double a[], double y[], const int iy[] ); extern void __cdecl VCUNPACKV (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int iy[]); extern void __cdecl VZUNPACKV (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int iy[]); extern void __cdecl vcunpackv (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int iy[]); extern void __cdecl vzunpackv (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int iy[]); extern void __cdecl vcUnpackV (const int n, const MKL_Complex8 a[], MKL_Complex8 y[], const int iy[]); extern void __cdecl vzUnpackV (const int n, const MKL_Complex16 a[], MKL_Complex16 y[], const int iy[]); extern void __cdecl VSUNPACKM (const int *n, const float a[], float y[], const int my[] ); extern void __cdecl VDUNPACKM (const int *n, const double a[], double y[], const int my[] ); extern void __cdecl vsunpackm (const int *n, const float a[], float y[], const int my[] ); extern void __cdecl vdunpackm (const int *n, const double a[], double y[], const int my[] ); extern void __cdecl vsUnpackM (const int n, const float a[], float y[], const int my[] ); extern void __cdecl vdUnpackM (const int n, const double a[], double y[], const int my[] ); extern void __cdecl VCUNPACKM (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int my[]); extern void __cdecl VZUNPACKM (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int my[]); extern void __cdecl vcunpackm (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int my[]); extern void __cdecl vzunpackm (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int my[]); extern void __cdecl vcUnpackM (const int n, const MKL_Complex8 a[], MKL_Complex8 y[], const int my[]); extern void __cdecl vzUnpackM (const int n, const MKL_Complex16 a[], MKL_Complex16 y[], const int my[]); extern int __cdecl VMLSETERRSTATUS (const int * status); extern int __cdecl vmlseterrstatus (const int * status); extern int __cdecl vmlSetErrStatus (const int status); extern int __cdecl VMLGETERRSTATUS (void); extern int __cdecl vmlgeterrstatus (void); extern int __cdecl vmlGetErrStatus (void); extern int __cdecl VMLCLEARERRSTATUS (void); extern int __cdecl vmlclearerrstatus (void); extern int __cdecl vmlClearErrStatus (void); extern VMLErrorCallBack __cdecl VMLSETERRORCALLBACK (const VMLErrorCallBack func); extern VMLErrorCallBack __cdecl vmlseterrorcallback (const VMLErrorCallBack func); extern VMLErrorCallBack __cdecl vmlSetErrorCallBack (const VMLErrorCallBack func); extern VMLErrorCallBack __cdecl VMLGETERRORCALLBACK (void); extern VMLErrorCallBack __cdecl vmlgeterrorcallback (void); extern VMLErrorCallBack __cdecl vmlGetErrorCallBack (void); extern VMLErrorCallBack __cdecl VMLCLEARERRORCALLBACK (void); extern VMLErrorCallBack __cdecl vmlclearerrorcallback (void); extern VMLErrorCallBack __cdecl vmlClearErrorCallBack (void); extern unsigned int __cdecl VMLSETMODE (const unsigned int *newmode); extern unsigned int __cdecl vmlsetmode (const unsigned int *newmode); extern unsigned int __cdecl vmlSetMode (const unsigned int newmode); extern unsigned int __cdecl VMLGETMODE (void); extern unsigned int __cdecl vmlgetmode (void); extern unsigned int __cdecl vmlGetMode (void); extern void __cdecl MKLFREETLS (const unsigned int *fdwReason); extern void __cdecl mklfreetls (const unsigned int *fdwReason); extern void __cdecl MKLFreeTls (const unsigned int fdwReason); #line 33 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 45 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 64 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 120 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 221 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 238 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 253 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 291 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 366 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 1031 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 1075 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 30 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_functions.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_types.h" typedef void* VSLStreamStatePtr; typedef void* VSLConvTaskPtr; typedef void* VSLCorrTaskPtr; typedef void* VSLSSTaskPtr; typedef int (*InitStreamPtr)( int method, VSLStreamStatePtr stream, int n, const unsigned int params[] ); typedef int (*sBRngPtr)( VSLStreamStatePtr stream, int n, float r[], float a, float b ); typedef int (*dBRngPtr)( VSLStreamStatePtr stream, int n, double r[], double a, double b ); typedef int (*iBRngPtr)( VSLStreamStatePtr stream, int n, unsigned int r[] ); typedef int (*iUpdateFuncPtr)( VSLStreamStatePtr stream, int* n, unsigned int ibuf[], int* nmin, int* nmax, int* idx ); typedef int (*dUpdateFuncPtr)( VSLStreamStatePtr stream, int* n, double dbuf[], int* nmin, int* nmax, int* idx ); typedef int (*sUpdateFuncPtr)( VSLStreamStatePtr stream, int* n, float sbuf[], int* nmin, int* nmax, int* idx ); typedef struct _VSLBRngProperties { int StreamStateSize; int NSeeds; int IncludesZero; int WordSize; int NBits; InitStreamPtr InitStream; sBRngPtr sBRng; dBRngPtr dBRng; iBRngPtr iBRng; } VSLBRngProperties; #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_functions.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_functions.h" extern int __cdecl vdRngCauchy (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGCAUCHY (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrngcauchy (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngCauchy (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGCAUCHY (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrngcauchy (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngUniform (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGUNIFORM (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnguniform (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngUniform (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGUNIFORM (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnguniform (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngGaussian (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGGAUSSIAN (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnggaussian (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngGaussian (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGGAUSSIAN (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnggaussian (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngGaussianMV (const int , VSLStreamStatePtr , const int , double [], const int , const int , const double *, const double *); extern int __cdecl VDRNGGAUSSIANMV (const int *, VSLStreamStatePtr *, const int *, double [], const int *, const int *, const double *, const double *); extern int __cdecl vdrnggaussianmv (const int *, VSLStreamStatePtr *, const int *, double [], const int *, const int *, const double *, const double *); extern int __cdecl vsRngGaussianMV (const int , VSLStreamStatePtr , const int , float [], const int , const int , const float *, const float * ); extern int __cdecl VSRNGGAUSSIANMV (const int *, VSLStreamStatePtr *, const int *, float [], const int *, const int *, const float *, const float * ); extern int __cdecl vsrnggaussianmv (const int *, VSLStreamStatePtr *, const int *, float [], const int *, const int *, const float *, const float * ); extern int __cdecl vdRngExponential (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGEXPONENTIAL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrngexponential (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngExponential (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGEXPONENTIAL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrngexponential (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngLaplace (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGLAPLACE (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnglaplace (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngLaplace (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGLAPLACE (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnglaplace (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngWeibull (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double ); extern int __cdecl VDRNGWEIBULL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vdrngweibull (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vsRngWeibull (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float ); extern int __cdecl VSRNGWEIBULL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vsrngweibull (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vdRngRayleigh (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGRAYLEIGH (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrngrayleigh (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngRayleigh (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGRAYLEIGH (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrngrayleigh (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngLognormal (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double , const double ); extern int __cdecl VDRNGLOGNORMAL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vdrnglognormal (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vsRngLognormal (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float , const float ); extern int __cdecl VSRNGLOGNORMAL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl vsrnglognormal (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl vdRngGumbel (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGGUMBEL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnggumbel (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngGumbel (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGGUMBEL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnggumbel (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngGamma (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double ); extern int __cdecl VDRNGGAMMA (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vdrnggamma (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vsRngGamma (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float ); extern int __cdecl VSRNGGAMMA (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vsrnggamma (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vdRngBeta (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double , const double ); extern int __cdecl VDRNGBETA (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vdrngbeta (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vsRngBeta (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float , const float ); extern int __cdecl VSRNGBETA (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl vsrngbeta (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl viRngBernoulli (const int , VSLStreamStatePtr , const int , int [], const double ); extern int __cdecl VIRNGBERNOULLI (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl virngbernoulli (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl viRngUniform (const int , VSLStreamStatePtr , const int , int [], const int , const int ); extern int __cdecl VIRNGUNIFORM (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *); extern int __cdecl virnguniform (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *); extern int __cdecl viRngUniformBits (const int , VSLStreamStatePtr , const int , unsigned int []); extern int __cdecl VIRNGUNIFORMBITS (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl virnguniformbits (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl viRngUniformBits32 (const int , VSLStreamStatePtr , const int , unsigned int []); extern int __cdecl VIRNGUNIFORMBITS32 (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl virnguniformbits32 (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl viRngUniformBits64 (const int , VSLStreamStatePtr , const int , unsigned long long int []); extern int __cdecl VIRNGUNIFORMBITS64 (const int *, VSLStreamStatePtr *, const int *, unsigned long long int []); extern int __cdecl virnguniformbits64 (const int *, VSLStreamStatePtr *, const int *, unsigned long long int []); extern int __cdecl viRngGeometric (const int , VSLStreamStatePtr , const int , int [], const double ); extern int __cdecl VIRNGGEOMETRIC (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl virnggeometric (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl viRngBinomial (const int , VSLStreamStatePtr , const int , int [], const int , const double ); extern int __cdecl VIRNGBINOMIAL (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const double *); extern int __cdecl virngbinomial (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const double *); extern int __cdecl viRngHypergeometric (const int , VSLStreamStatePtr , const int , int [], const int , const int , const int ); extern int __cdecl VIRNGHYPERGEOMETRIC (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *, const int *); extern int __cdecl virnghypergeometric (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *, const int *); extern int __cdecl viRngNegbinomial (const int , VSLStreamStatePtr , const int , int [], const double , const double ); extern int __cdecl viRngNegBinomial (const int , VSLStreamStatePtr , const int , int [], const double , const double ); extern int __cdecl VIRNGNEGBINOMIAL (const int *, VSLStreamStatePtr *, const int *, int [], const double *, const double *); extern int __cdecl virngnegbinomial (const int *, VSLStreamStatePtr *, const int *, int [], const double *, const double *); extern int __cdecl viRngPoisson (const int , VSLStreamStatePtr , const int , int [], const double ); extern int __cdecl VIRNGPOISSON (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl virngpoisson (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl viRngPoissonV (const int , VSLStreamStatePtr , const int , int [], const double []); extern int __cdecl VIRNGPOISSONV (const int *, VSLStreamStatePtr *, const int *, int [], const double []); extern int __cdecl virngpoissonv (const int *, VSLStreamStatePtr *, const int *, int [], const double []); extern int __cdecl vslNewStream (VSLStreamStatePtr* , const int , const unsigned int ); extern int __cdecl vslnewstream (VSLStreamStatePtr* , const int *, const unsigned int *); extern int __cdecl VSLNEWSTREAM (VSLStreamStatePtr* , const int *, const unsigned int *); extern int __cdecl vslNewStreamEx (VSLStreamStatePtr* , const int , const int , const unsigned int[]); extern int __cdecl vslnewstreamex (VSLStreamStatePtr* , const int *, const int *, const unsigned int[]); extern int __cdecl VSLNEWSTREAMEX (VSLStreamStatePtr* , const int *, const int *, const unsigned int[]); extern int __cdecl vsliNewAbstractStream (VSLStreamStatePtr* , const int , const unsigned int[], const iUpdateFuncPtr); extern int __cdecl vslinewabstractstream (VSLStreamStatePtr* , const int *, const unsigned int[], const iUpdateFuncPtr); extern int __cdecl VSLINEWABSTRACTSTREAM (VSLStreamStatePtr* , const int *, const unsigned int[], const iUpdateFuncPtr); extern int __cdecl vsldNewAbstractStream (VSLStreamStatePtr* , const int , const double[], const double , const double , const dUpdateFuncPtr); extern int __cdecl vsldnewabstractstream (VSLStreamStatePtr* , const int *, const double[], const double *, const double *, const dUpdateFuncPtr); extern int __cdecl VSLDNEWABSTRACTSTREAM (VSLStreamStatePtr* , const int *, const double[], const double *, const double *, const dUpdateFuncPtr); extern int __cdecl vslsNewAbstractStream (VSLStreamStatePtr* , const int , const float[], const float , const float , const sUpdateFuncPtr); extern int __cdecl vslsnewabstractstream (VSLStreamStatePtr* , const int *, const float[], const float *, const float *, const sUpdateFuncPtr); extern int __cdecl VSLSNEWABSTRACTSTREAM (VSLStreamStatePtr* , const int *, const float[], const float *, const float *, const sUpdateFuncPtr); extern int __cdecl vslDeleteStream (VSLStreamStatePtr*); extern int __cdecl vsldeletestream (VSLStreamStatePtr*); extern int __cdecl VSLDELETESTREAM (VSLStreamStatePtr*); extern int __cdecl vslCopyStream (VSLStreamStatePtr*, const VSLStreamStatePtr); extern int __cdecl vslcopystream (VSLStreamStatePtr*, const VSLStreamStatePtr); extern int __cdecl VSLCOPYSTREAM (VSLStreamStatePtr*, const VSLStreamStatePtr); extern int __cdecl vslCopyStreamState (VSLStreamStatePtr , const VSLStreamStatePtr ); extern int __cdecl vslcopystreamstate (VSLStreamStatePtr *, const VSLStreamStatePtr *); extern int __cdecl VSLCOPYSTREAMSTATE (VSLStreamStatePtr *, const VSLStreamStatePtr *); extern int __cdecl vslLeapfrogStream (VSLStreamStatePtr , const int , const int ); extern int __cdecl vslleapfrogstream (VSLStreamStatePtr *, const int *, const int *); extern int __cdecl VSLLEAPFROGSTREAM (VSLStreamStatePtr *, const int *, const int *); extern int __cdecl vslSkipAheadStream (VSLStreamStatePtr , const __int64 ); extern int __cdecl vslskipaheadstream (VSLStreamStatePtr *, const __int64 *); extern int __cdecl VSLSKIPAHEADSTREAM (VSLStreamStatePtr *, const __int64 *); extern int __cdecl vslGetStreamStateBrng (const VSLStreamStatePtr ); extern int __cdecl vslgetstreamstatebrng (const VSLStreamStatePtr *); extern int __cdecl VSLGETSTREAMSTATEBRNG (const VSLStreamStatePtr *); extern int __cdecl vslGetNumRegBrngs (void); extern int __cdecl vslgetnumregbrngs (void); extern int __cdecl VSLGETNUMREGBRNGS (void); extern int __cdecl vslRegisterBrng (const VSLBRngProperties* ); extern int __cdecl vslregisterbrng (const VSLBRngProperties* ); extern int __cdecl VSLREGISTERBRNG (const VSLBRngProperties* ); extern int __cdecl vslGetBrngProperties (const int , VSLBRngProperties* ); extern int __cdecl vslgetbrngproperties (const int *, VSLBRngProperties* ); extern int __cdecl VSLGETBRNGPROPERTIES (const int *, VSLBRngProperties* ); extern int __cdecl vslSaveStreamF (const VSLStreamStatePtr , const char* ); extern int __cdecl vslsavestreamf (const VSLStreamStatePtr *, const char* , const int ); extern int __cdecl VSLSAVESTREAMF (const VSLStreamStatePtr *, const char* , const int ); extern int __cdecl vslLoadStreamF (VSLStreamStatePtr *, const char* ); extern int __cdecl vslloadstreamf (VSLStreamStatePtr *, const char* , const int ); extern int __cdecl VSLLOADSTREAMF (VSLStreamStatePtr *, const char* , const int ); extern int __cdecl vslSaveStreamM (const VSLStreamStatePtr , char* ); extern int __cdecl vslsavestreamm (const VSLStreamStatePtr *, char* ); extern int __cdecl VSLSAVESTREAMM (const VSLStreamStatePtr *, char* ); extern int __cdecl vslLoadStreamM (VSLStreamStatePtr *, const char* ); extern int __cdecl vslloadstreamm (VSLStreamStatePtr *, const char* ); extern int __cdecl VSLLOADSTREAMM (VSLStreamStatePtr *, const char* ); extern int __cdecl vslGetStreamSize (const VSLStreamStatePtr); extern int __cdecl vslgetstreamsize (const VSLStreamStatePtr); extern int __cdecl VSLGETSTREAMSIZE (const VSLStreamStatePtr); extern int __cdecl vsldConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vsldconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLDCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslsConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslsconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLSCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslzConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslzconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLZCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslcConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslcconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLCCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vsldCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vsldcorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLDCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslsCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslscorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLSCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslzCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslzcorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLZCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslcCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslccorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLCCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vsldConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vsldconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLDCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslsConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslsconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLSCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslzConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslzconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLZCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslcConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslcconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLCCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vsldCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vsldcorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLDCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslsCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslscorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLSCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslzCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslzcorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLZCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslcCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslccorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLCCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vsldConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vsldconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl VSLDCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vslsConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslsconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl VSLSCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslzConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslzconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl VSLZCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslcConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vslcconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl VSLCCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vsldCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vsldcorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl VSLDCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vslsCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslscorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl VSLSCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslzCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslzcorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl VSLZCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslcCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vslccorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl VSLCCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vsldConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const double [], const int ); extern int __cdecl vsldconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl VSLDCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl vslsConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const float [], const int ); extern int __cdecl vslsconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl VSLSCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl vslzConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const MKL_Complex16 [], const int ); extern int __cdecl vslzconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl VSLZCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl vslcConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const MKL_Complex8 [], const int ); extern int __cdecl vslcconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl VSLCCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl vsldCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const double [], const int ); extern int __cdecl vsldcorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl VSLDCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl vslsCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const float [], const int ); extern int __cdecl vslscorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl VSLSCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl vslzCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const MKL_Complex16 [], const int ); extern int __cdecl vslzcorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl VSLZCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl vslcCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const MKL_Complex8 [], const int ); extern int __cdecl vslccorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl VSLCCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl vslConvDeleteTask (VSLConvTaskPtr* ); extern int __cdecl vslconvdeletetask (VSLConvTaskPtr* ); extern int __cdecl VSLCONVDeleteTask (VSLConvTaskPtr* ); extern int __cdecl vslCorrDeleteTask (VSLCorrTaskPtr* ); extern int __cdecl vslcorrdeletetask (VSLCorrTaskPtr* ); extern int __cdecl VSLCORRDeleteTask (VSLCorrTaskPtr* ); extern int __cdecl vslConvCopyTask (VSLConvTaskPtr* , const VSLConvTaskPtr ); extern int __cdecl vslconvcopytask (VSLConvTaskPtr* , const VSLConvTaskPtr* ); extern int __cdecl VSLCONVCopyTask (VSLConvTaskPtr* , const VSLConvTaskPtr* ); extern int __cdecl vslCorrCopyTask (VSLCorrTaskPtr* , const VSLCorrTaskPtr ); extern int __cdecl vslcorrcopytask (VSLCorrTaskPtr* , const VSLCorrTaskPtr* ); extern int __cdecl VSLCORRCopyTask (VSLCorrTaskPtr* , const VSLCorrTaskPtr* ); extern int __cdecl vslConvSetMode (VSLConvTaskPtr , const int ); extern int __cdecl vslconvsetmode (VSLConvTaskPtr* , const int* ); extern int __cdecl VSLCONVSETMODE (VSLConvTaskPtr* , const int* ); extern int __cdecl vslCorrSetMode (VSLCorrTaskPtr , const int ); extern int __cdecl vslcorrsetmode (VSLCorrTaskPtr* , const int* ); extern int __cdecl VSLCORRSETMODE (VSLCorrTaskPtr* , const int* ); extern int __cdecl vslConvSetInternalPrecision (VSLConvTaskPtr , const int ); extern int __cdecl vslconvsetinternalprecision (VSLConvTaskPtr* , const int* ); extern int __cdecl VSLCONVSETINTERNALPRECISION (VSLConvTaskPtr* , const int* ); extern int __cdecl vslCorrSetInternalPrecision (VSLCorrTaskPtr , const int ); extern int __cdecl vslcorrsetinternalprecision (VSLCorrTaskPtr* , const int* ); extern int __cdecl VSLCORRSETINTERNALPRECISION (VSLCorrTaskPtr* , const int* ); extern int __cdecl vslConvSetStart (VSLConvTaskPtr , const int []); extern int __cdecl vslconvsetstart (VSLConvTaskPtr* , const int []); extern int __cdecl VSLCONVSETSTART (VSLConvTaskPtr* , const int []); extern int __cdecl vslCorrSetStart (VSLCorrTaskPtr , const int []); extern int __cdecl vslcorrsetstart (VSLCorrTaskPtr* , const int []); extern int __cdecl VSLCORRSETSTART (VSLCorrTaskPtr* , const int []); extern int __cdecl vslConvSetDecimation (VSLConvTaskPtr , const int []); extern int __cdecl vslconvsetdecimation (VSLConvTaskPtr* , const int []); extern int __cdecl VSLCONVSETDECIMATION (VSLConvTaskPtr* , const int []); extern int __cdecl vslCorrSetDecimation (VSLCorrTaskPtr , const int []); extern int __cdecl vslcorrsetdecimation (VSLCorrTaskPtr* , const int []); extern int __cdecl VSLCORRSETDECIMATION (VSLCorrTaskPtr* , const int []); extern int __cdecl vsldConvExec (VSLConvTaskPtr , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vsldconvexec (VSLConvTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl VSLDCONVEXEC (VSLConvTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vslsConvExec (VSLConvTaskPtr , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslsconvexec (VSLConvTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl VSLSCONVEXEC (VSLConvTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslzConvExec (VSLConvTaskPtr , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzconvexec (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCONVEXEC (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcConvExec (VSLConvTaskPtr , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslcconvexec (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCONVEXEC (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldCorrExec (VSLCorrTaskPtr , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vsldcorrexec (VSLCorrTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl VSLDCORREXEC (VSLCorrTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vslsCorrExec (VSLCorrTaskPtr , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslscorrexec (VSLCorrTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl VSLSCORREXEC (VSLCorrTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslzCorrExec (VSLCorrTaskPtr , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzcorrexec (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCORREXEC (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcCorrExec (VSLCorrTaskPtr , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslccorrexec (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCORREXEC (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldConvExec1D (VSLConvTaskPtr , const double [], const int , const double [], const int , double [], const int ); extern int __cdecl vsldconvexec1d (VSLConvTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCONVEXEC1D (VSLConvTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl vslsConvExec1D (VSLConvTaskPtr , const float [], const int , const float [], const int , float [], const int ); extern int __cdecl vslsconvexec1d (VSLConvTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCONVEXEC1D (VSLConvTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl vslzConvExec1D (VSLConvTaskPtr , const MKL_Complex16 [], const int , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzconvexec1d (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCONVEXEC1D (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcConvExec1D (VSLConvTaskPtr , const MKL_Complex8 [], const int , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslcconvexec1d (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCONVEXEC1D (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldCorrExec1D (VSLCorrTaskPtr , const double [], const int , const double [], const int , double [], const int ); extern int __cdecl vsldcorrexec1d (VSLCorrTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCORREXEC1D (VSLCorrTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl vslsCorrExec1D (VSLCorrTaskPtr , const float [], const int , const float [], const int , float [], const int ); extern int __cdecl vslscorrexec1d (VSLCorrTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCORREXEC1D (VSLCorrTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl vslzCorrExec1D (VSLCorrTaskPtr , const MKL_Complex16 [], const int , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzcorrexec1d (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCORREXEC1D (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcCorrExec1D (VSLCorrTaskPtr , const MKL_Complex8 [], const int , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslccorrexec1d (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCORREXEC1D (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldConvExecX (VSLConvTaskPtr , const double [], const int [], double [], const int []); extern int __cdecl vsldconvexecx (VSLConvTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl VSLDCONVEXECX (VSLConvTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl vslsConvExecX (VSLConvTaskPtr , const float [], const int [], float [], const int []); extern int __cdecl vslsconvexecx (VSLConvTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl VSLSCONVEXECX (VSLConvTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl vslzConvExecX (VSLConvTaskPtr , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzconvexecx (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCONVEXECX (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcConvExecX (VSLConvTaskPtr , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslcconvexecx (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCONVEXECX (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldCorrExecX (VSLCorrTaskPtr , const double [], const int [], double [], const int []); extern int __cdecl vsldcorrexecx (VSLCorrTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl VSLDCORREXECX (VSLCorrTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl vslsCorrExecX (VSLCorrTaskPtr , const float [], const int [], float [], const int []); extern int __cdecl vslscorrexecx (VSLCorrTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl VSLSCORREXECX (VSLCorrTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl vslzCorrExecX (VSLCorrTaskPtr , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzcorrexecx (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCORREXECX (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcCorrExecX (VSLCorrTaskPtr , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslccorrexecx (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCORREXECX (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldConvExecX1D (VSLConvTaskPtr , const double [], const int , double [], const int ); extern int __cdecl vsldconvexecx1d (VSLConvTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCONVEXECX1D (VSLConvTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl vslsConvExecX1D (VSLConvTaskPtr , const float [], const int , float [], const int ); extern int __cdecl vslsconvexecx1d (VSLConvTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCONVEXECX1D (VSLConvTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl vslzConvExecX1D (VSLConvTaskPtr , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzconvexecx1d (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCONVEXECX1D (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcConvExecX1D (VSLConvTaskPtr , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslcconvexecx1d (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCONVEXECX1D (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldCorrExecX1D (VSLCorrTaskPtr , const double [], const int , double [], const int ); extern int __cdecl vsldcorrexecx1d (VSLCorrTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCORREXECX1D (VSLCorrTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl vslsCorrExecX1D (VSLCorrTaskPtr , const float [], const int , float [], const int ); extern int __cdecl vslscorrexecx1d (VSLCorrTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCORREXECX1D (VSLCorrTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl vslzCorrExecX1D (VSLCorrTaskPtr , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzcorrexecx1d (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCORREXECX1D (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcCorrExecX1D (VSLCorrTaskPtr , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslccorrexecx1d (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCORREXECX1D (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldSSNewTask (VSLSSTaskPtr* , const int* , const int* , const int* , const double [], const double [], const int []); extern int __cdecl vsldssnewtask (VSLSSTaskPtr* , const int* , const int* , const int* , const double [], const double [], const int []); extern int __cdecl VSLDSSNEWTASK (VSLSSTaskPtr* , const int* , const int* , const int* , const double [], const double [], const int []); extern int __cdecl vslsSSNewTask (VSLSSTaskPtr* , const int* , const int* , const int* , const float [], const float [], const int []); extern int __cdecl vslsssnewtask (VSLSSTaskPtr* , const int* , const int* , const int* , const float [], const float [], const int []); extern int __cdecl VSLSSSNEWTASK (VSLSSTaskPtr* , const int* , const int* , const int* , const float [], const float [], const int []); extern int __cdecl vsldSSEditTask (VSLSSTaskPtr , const int , const double* ); extern int __cdecl vsldssedittask (VSLSSTaskPtr* , const int* , const double* ); extern int __cdecl VSLDSSEDITTASK (VSLSSTaskPtr* , const int* , const double* ); extern int __cdecl vslsSSEditTask (VSLSSTaskPtr , const int , const float* ); extern int __cdecl vslsssedittask (VSLSSTaskPtr* , const int* , const float* ); extern int __cdecl VSLSSSEDITTASK (VSLSSTaskPtr* , const int* , const float* ); extern int __cdecl vsliSSEditTask (VSLSSTaskPtr , const int , const int* ); extern int __cdecl vslissedittask (VSLSSTaskPtr* , const int* , const int* ); extern int __cdecl VSLISSEDITTASK (VSLSSTaskPtr* , const int* , const int* ); extern int __cdecl vsldSSEditMoments (VSLSSTaskPtr , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vsldsseditmoments (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl VSLDSSEDITMOMENTS (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vslsSSEditMoments (VSLSSTaskPtr , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vslssseditmoments (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl VSLSSSEDITMOMENTS (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vsldSSEditSums (VSLSSTaskPtr , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vsldsseditsums (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl VSLDSSEDITSUMS (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vslsSSEditSums (VSLSSTaskPtr , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vslssseditsums (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl VSLSSSEDITSUMS (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vsldSSEditCovCor (VSLSSTaskPtr , double* , double* , const int* , double* , const int* ); extern int __cdecl vsldsseditcovcor (VSLSSTaskPtr* , double* , double* , const int* , double* , const int* ); extern int __cdecl VSLDSSEDITCOVCOR (VSLSSTaskPtr* , double* , double* , const int* , double* , const int* ); extern int __cdecl vslsSSEditCovCor (VSLSSTaskPtr , float* , float* , const int* , float* , const int* ); extern int __cdecl vslssseditcovcor (VSLSSTaskPtr* , float* , float* , const int* , float* , const int* ); extern int __cdecl VSLSSSEDITCOVCOR (VSLSSTaskPtr* , float* , float* , const int* , float* , const int* ); extern int __cdecl vsldSSEditCP (VSLSSTaskPtr , double* , double* , double* , const int* ); extern int __cdecl vsldsseditcp (VSLSSTaskPtr* , double* , double* , double* , const int* ); extern int __cdecl VSLDSSEDITCP (VSLSSTaskPtr* , double* , double* , double* , const int* ); extern int __cdecl vslsSSEditCP (VSLSSTaskPtr , float* , float* , float* , const int* ); extern int __cdecl vslssseditcp (VSLSSTaskPtr* , float* , float* , float* , const int* ); extern int __cdecl VSLSSSEDITCP (VSLSSTaskPtr* , float* , float* , float* , const int* ); extern int __cdecl vsldSSEditPartialCovCor (VSLSSTaskPtr , const int [], const double* , const int* , const double* , const int* , double* , const int* , double* , const int* ); extern int __cdecl vsldsseditpartialcovcor (VSLSSTaskPtr* , const int [], const double* , const int* , const double* , const int* , double* , const int* , double* , const int* ); extern int __cdecl VSLDSSEDITPARTIALCOVCOR (VSLSSTaskPtr* , const int [], const double* , const int* , const double* , const int* , double* , const int* , double* , const int* ); extern int __cdecl vslsSSEditPartialCovCor (VSLSSTaskPtr , const int [], const float* , const int* , const float* , const int* , float* , const int* , float* , const int* ); extern int __cdecl vslssseditpartialcovcor (VSLSSTaskPtr* , const int [], const float* , const int* , const float* , const int* , float* , const int* , float* , const int* ); extern int __cdecl VSLSSSEDITPARTIALCOVCOR (VSLSSTaskPtr* , const int [], const float* , const int* , const float* , const int* , float* , const int* , float* , const int* ); extern int __cdecl vsldSSEditQuantiles (VSLSSTaskPtr , const int* , const double* , double* , double* , const int* ); extern int __cdecl vsldsseditquantiles (VSLSSTaskPtr* , const int* , const double* , double* , double* , const int* ); extern int __cdecl VSLDSSEDITQUANTILES (VSLSSTaskPtr* , const int* , const double* , double* , double* , const int* ); extern int __cdecl vslsSSEditQuantiles (VSLSSTaskPtr , const int* , const float* , float* , float* , const int* ); extern int __cdecl vslssseditquantiles (VSLSSTaskPtr* , const int* , const float* , float* , float* , const int* ); extern int __cdecl VSLSSSEDITQUANTILES (VSLSSTaskPtr* , const int* , const float* , float* , float* , const int* ); extern int __cdecl vsldSSEditStreamQuantiles (VSLSSTaskPtr , const int* , const double* , double* , const int* , const double* ); extern int __cdecl vsldsseditstreamquantiles (VSLSSTaskPtr* , const int* , const double* , double* , const int* , const double* ); extern int __cdecl VSLDSSEDITSTREAMQUANTILES (VSLSSTaskPtr* , const int* , const double* , double* , const int* , const double* ); extern int __cdecl vslsSSEditStreamQuantiles (VSLSSTaskPtr , const int* , const float* , float* , const int* , const float* ); extern int __cdecl vslssseditstreamquantiles (VSLSSTaskPtr* , const int* , const float* , float* , const int* , const float* ); extern int __cdecl VSLSSSEDITSTREAMQUANTILES (VSLSSTaskPtr* , const int* , const float* , float* , const int* , const float* ); extern int __cdecl vsldSSEditPooledCovariance (VSLSSTaskPtr , const int* , double* , double* , const int* , double* , double* ); extern int __cdecl vsldsseditpooledcovariance (VSLSSTaskPtr* , const int* , double* , double* , const int* , double* , double* ); extern int __cdecl VSLDSSEDITPOOLEDCOVARIANCE (VSLSSTaskPtr* , const int* , double* , double* , const int* , double* , double* ); extern int __cdecl vslsSSEditPooledCovariance (VSLSSTaskPtr , const int* , float* , float* , const int* , float* , float* ); extern int __cdecl vslssseditpooledcovariance (VSLSSTaskPtr* , const int* , float* , float* , const int* , float* , float* ); extern int __cdecl VSLSSSEDITPOOLEDCOVARIANCE (VSLSSTaskPtr* , const int* , float* , float* , const int* , float* , float* ); extern int __cdecl vsldSSEditRobustCovariance (VSLSSTaskPtr , const int* , const int* , const double* , double* , double* ); extern int __cdecl vsldsseditrobustcovariance (VSLSSTaskPtr* , const int* , const int* , const double* , double* , double* ); extern int __cdecl VSLDSSEDITROBUSTCOVARIANCE (VSLSSTaskPtr* , const int* , const int* , const double* , double* , double* ); extern int __cdecl vslsSSEditRobustCovariance (VSLSSTaskPtr , const int* , const int* , const float* , float* , float* ); extern int __cdecl vslssseditrobustcovariance (VSLSSTaskPtr* , const int* , const int* , const float* , float* , float* ); extern int __cdecl VSLSSSEDITROBUSTCOVARIANCE (VSLSSTaskPtr* , const int* , const int* , const float* , float* , float* ); extern int __cdecl vsldSSEditOutliersDetection (VSLSSTaskPtr , const int* , const double* , double* ); extern int __cdecl vsldsseditoutliersdetection (VSLSSTaskPtr* , const int* , const double* , double* ); extern int __cdecl VSLDSSEDITOUTLIERSDETECTION (VSLSSTaskPtr* , const int* , const double* , double* ); extern int __cdecl vslsSSEditOutliersDetection (VSLSSTaskPtr , const int* , const float* , float* ); extern int __cdecl vslssseditoutliersdetection (VSLSSTaskPtr* , const int* , const float* , float* ); extern int __cdecl VSLSSSEDITOUTLIERSDETECTION (VSLSSTaskPtr* , const int* , const float* , float* ); extern int __cdecl vsldSSEditMissingValues (VSLSSTaskPtr , const int* , const double* , const int* , const double* , const int* , const double* , const int* , double* , const int* , double* ); extern int __cdecl vsldsseditmissingvalues (VSLSSTaskPtr* , const int* , const double* , const int* , const double* , const int* , const double* , const int* , double* , const int* , double* ); extern int __cdecl VSLDSSEDITMISSINGVALUES (VSLSSTaskPtr* , const int* , const double* , const int* , const double* , const int* , const double* , const int* , double* , const int* , double* ); extern int __cdecl vslsSSEditMissingValues (VSLSSTaskPtr , const int* , const float* , const int* , const float* , const int* , const float* , const int* , float* , const int* , float* ); extern int __cdecl vslssseditmissingvalues (VSLSSTaskPtr* , const int* , const float* , const int* , const float* , const int* , const float* , const int* , float* , const int* , float* ); extern int __cdecl VSLSSSEDITMISSINGVALUES (VSLSSTaskPtr* , const int* , const float* , const int* , const float* , const int* , const float* , const int* , float* , const int* , float* ); extern int __cdecl vsldSSEditCorParameterization (VSLSSTaskPtr , const double* , const int* , double* , const int* ); extern int __cdecl vsldsseditcorparameterization (VSLSSTaskPtr* , const double* , const int* , double* , const int* ); extern int __cdecl VSLDSSEDITCORPARAMETERIZATION (VSLSSTaskPtr* , const double* , const int* , double* , const int* ); extern int __cdecl vslsSSEditCorParameterization (VSLSSTaskPtr , const float* , const int* , float* , const int* ); extern int __cdecl vslssseditcorparameterization (VSLSSTaskPtr* , const float* , const int* , float* , const int* ); extern int __cdecl VSLSSSEDITCORPARAMETERIZATION (VSLSSTaskPtr* , const float* , const int* , float* , const int* ); extern int __cdecl vsldSSCompute (VSLSSTaskPtr , const unsigned long long int , const int ); extern int __cdecl vsldsscompute (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl VSLDSSCOMPUTE (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl vslsSSCompute (VSLSSTaskPtr , const unsigned long long int , const int ); extern int __cdecl vslssscompute (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl VSLSSSCOMPUTE (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl vslSSDeleteTask (VSLSSTaskPtr* ); extern int __cdecl vslssdeletetask (VSLSSTaskPtr* ); extern int __cdecl VSLSSDELETETASK (VSLSSTaskPtr* ); #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl.h" #line 51 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 73 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 91 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 130 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 157 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 172 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 30 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_functions.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_types.h" typedef void* DFTaskPtr; typedef struct _dfSearchCallBackLibraryParams{ int limit_type_flag; } dfSearchCallBackLibraryParams; typedef struct _dfInterpCallBackLibraryParams{ int reserved1; } dfInterpCallBackLibraryParams; typedef struct _dfIntegrCallBackLibraryParams{ int reserved1; } dfIntegrCallBackLibraryParams; typedef int (*dfsInterpCallBack) ( long long int* n, long long int cell[], float site[], float r[], void* user_param, dfInterpCallBackLibraryParams* library_params ); typedef int (*dfdInterpCallBack) ( long long int* n, long long int cell[], double site[], double r[], void* user_param, dfInterpCallBackLibraryParams* library_params ); typedef int (*dfsIntegrCallBack) ( long long int* n, long long int lcell[], float llim[], long long int rcell[], float rlim[], float r[], void* user_params, dfIntegrCallBackLibraryParams* library_params ); typedef int (*dfdIntegrCallBack) ( long long int* n, long long int lcell[], double llim[], long long int rcell[], double rlim[], double r[], void* user_params, dfIntegrCallBackLibraryParams* library_params ); typedef int (*dfsSearchCellsCallBack) ( long long int* n, float site[], long long int cell[], int flag[], void* user_params, dfSearchCallBackLibraryParams* library_params ); typedef int (*dfdSearchCellsCallBack) ( long long int* n, double site[], long long int cell[], int flag[], void* user_params, dfSearchCallBackLibraryParams* library_params ); #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_functions.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_functions.h" extern int __cdecl dfsNewTask1D (DFTaskPtr *, const int , const float [], const int , const int , const float [], const int ); extern int __cdecl dfsnewtask1d (DFTaskPtr *, const int *, const float [], const int *, const int *, const float [], const int *); extern int __cdecl DFSNEWTASK1D (DFTaskPtr *, const int *, const float [], const int *, const int *, const float [], const int *); extern int __cdecl dfdNewTask1D (DFTaskPtr *, const int , const double [], const int , const int , const double [], const int ); extern int __cdecl dfdnewtask1d (DFTaskPtr *, const int *, const double [], const int *, const int *, const double [], const int *); extern int __cdecl DFDNEWTASK1D (DFTaskPtr *, const int *, const double [], const int *, const int *, const double [], const int *); extern int __cdecl dfsEditPtr (DFTaskPtr , const int , const float *); extern int __cdecl dfseditptr (DFTaskPtr *, const int *, const float *); extern int __cdecl DFSEDITPTR (DFTaskPtr *, const int *, const float *); extern int __cdecl dfdEditPtr (DFTaskPtr , const int , const double *); extern int __cdecl dfdeditptr (DFTaskPtr *, const int *, const double *); extern int __cdecl DFDEDITPTR (DFTaskPtr *, const int *, const double *); extern int __cdecl dfiEditVal (DFTaskPtr , const int , const int ); extern int __cdecl dfieditval (DFTaskPtr *, const int *, const int *); extern int __cdecl DFIEDITVAL (DFTaskPtr *, const int *, const int *); extern int __cdecl dfsEditIdxPtr (DFTaskPtr , const int , const int , const float []); extern int __cdecl dfseditidxptr (DFTaskPtr *, const int *, const int *, const float []); extern int __cdecl DFSEDITIDXPTR (DFTaskPtr *, const int *, const int *, const float []); extern int __cdecl dfdEditIdxPtr (DFTaskPtr , const int , const int , const double []); extern int __cdecl dfdeditidxptr (DFTaskPtr *, const int *, const int *, const double []); extern int __cdecl DFDEDITIDXPTR (DFTaskPtr *, const int *, const int *, const double []); extern int __cdecl dfsEditPPSpline1D (DFTaskPtr , const int , const int , const int , const float [], const int , const float [], const float [], const int ); extern int __cdecl dfseditppspline1d (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const float [], const float [], const int *); extern int __cdecl DFSEDITPPSPLINE1D (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const float [], const float [], const int *); extern int __cdecl dfdEditPPSpline1D (DFTaskPtr , const int , const int , const int , const double [], const int , const double [], const double [], const int ); extern int __cdecl dfdeditppspline1d (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const double [], const double [], const int *); extern int __cdecl DFDEDITPPSPLINE1D (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const double [], const double [], const int *); extern int __cdecl dfsQueryPtr (DFTaskPtr , const int , float **); extern int __cdecl dfsqueryptr (DFTaskPtr *, const int *, float **); extern int __cdecl DFSQUERYPTR (DFTaskPtr *, const int *, float **); extern int __cdecl dfdQueryPtr (DFTaskPtr , const int , double **); extern int __cdecl dfdqueryptr (DFTaskPtr *, const int *, double **); extern int __cdecl DFDQUERYPTR (DFTaskPtr *, const int *, double **); extern int __cdecl dfiQueryVal (DFTaskPtr , const int , int *); extern int __cdecl dfiqueryval (DFTaskPtr *, const int *, int *); extern int __cdecl DFIQUERYVAL (DFTaskPtr *, const int *, int *); extern int __cdecl dfsQueryIdxPtr (DFTaskPtr , const int , const int , float **); extern int __cdecl dfsqueryidxptr (DFTaskPtr *, const int *, const int *, float **); extern int __cdecl DFSQUERYIDXPTR (DFTaskPtr *, const int *, const int *, float **); extern int __cdecl dfdQueryIdxPtr (DFTaskPtr , const int , const int , double **); extern int __cdecl dfdqueryidxptr (DFTaskPtr *, const int *, const int *, double **); extern int __cdecl DFDQUERYIDXPTR (DFTaskPtr *, const int *, const int *, double **); extern int __cdecl dfsConstruct1D (DFTaskPtr , const int , const int ); extern int __cdecl dfsconstruct1d (DFTaskPtr *, const int *, const int *); extern int __cdecl DFSCONSTRUCT1D (DFTaskPtr *, const int *, const int *); extern int __cdecl dfdConstruct1D (DFTaskPtr , const int , const int ); extern int __cdecl dfdconstruct1d (DFTaskPtr *, const int *, const int *); extern int __cdecl DFDCONSTRUCT1D (DFTaskPtr *, const int *, const int *); extern int __cdecl dfsInterpolateEx1D (DFTaskPtr , const int , const int , const int , const float [], const int , const int , const int [], const float [], float [], const int , int [], const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfsinterpolateex1d (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [], const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl DFSINTERPOLATEEX1D (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [], const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfdInterpolateEx1D (DFTaskPtr , const int , const int , const int , const double [], const int , const int , const int [], const double [], double [], const int , int [], const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfdinterpolateex1d (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [], const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl DFDINTERPOLATEEX1D (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [], const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfsInterpolate1D (DFTaskPtr , const int , const int , const int , const float [], const int , const int , const int [], const float [], float [], const int , int [] ); extern int __cdecl dfsinterpolate1d (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [] ); extern int __cdecl DFSINTERPOLATE1D (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [] ); extern int __cdecl dfdInterpolate1D (DFTaskPtr , const int , const int , const int , const double [], const int , const int , const int [], const double [], double [], const int , int [] ); extern int __cdecl dfdinterpolate1d (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [] ); extern int __cdecl DFDINTERPOLATE1D (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [] ); extern int __cdecl dfsSearchCellsEx1D (DFTaskPtr , const int , const int , const float [], const int , const float [], int [], const dfsSearchCellsCallBack , const void * ); extern int __cdecl dfssearchcellsex1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [], const dfsSearchCellsCallBack , const void * ); extern int __cdecl DFSSEARCHCELLSEX1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [], const dfsSearchCellsCallBack , const void * ); extern int __cdecl dfdSearchCellsEx1D (DFTaskPtr , const int , const int , const double [], const int , const double [], int [], const dfdSearchCellsCallBack , const void * ); extern int __cdecl dfdsearchcellsex1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [], const dfdSearchCellsCallBack , const void * ); extern int __cdecl DFDSEARCHCELLSEX1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [], const dfdSearchCellsCallBack , const void * ); extern int __cdecl dfsSearchCells1D (DFTaskPtr , const int , const int , const float [], const int , const float [], int [] ); extern int __cdecl dfssearchcells1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [] ); extern int __cdecl DFSSEARCHCELLS1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [] ); extern int __cdecl dfdSearchCells1D (DFTaskPtr , const int , const int , const double [], const int , const double [], int [] ); extern int __cdecl dfdsearchcells1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [] ); extern int __cdecl DFDSEARCHCELLS1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [] ); extern int __cdecl dfsIntegrate1D (DFTaskPtr , const int , const int , const float [], const int , const float [], const int , const float [], const float [], float [], const int ); extern int __cdecl dfsintegrate1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *); extern int __cdecl DFSINTEGRATE1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *); extern int __cdecl dfdIntegrate1D (DFTaskPtr , const int , const int , const double [], const int , const double [], const int , const double [], const double [], double [], const int ); extern int __cdecl dfdintegrate1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *); extern int __cdecl DFDINTEGRATE1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *); extern int __cdecl dfsIntegrateEx1D (DFTaskPtr , const int , const int , const float [], const int , const float [], const int , const float [], const float [], float [], const int , const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfsintegrateex1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl DFSINTEGRATEEX1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfdIntegrateEx1D (DFTaskPtr , const int , const int , const double [], const int , const double [], const int , const double [], const double [], double [], const int , const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfdintegrateex1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl DFDINTEGRATEEX1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfDeleteTask (DFTaskPtr *); extern int __cdecl dfdeletetask (DFTaskPtr *); extern int __cdecl DFDELETETASK (DFTaskPtr *); #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df.h" #line 52 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" #line 45 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" #line 58 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" enum DFTI_CONFIG_PARAM { DFTI_FORWARD_DOMAIN = 0, DFTI_DIMENSION = 1, DFTI_LENGTHS = 2, DFTI_PRECISION = 3, DFTI_FORWARD_SCALE = 4, DFTI_BACKWARD_SCALE = 5, DFTI_NUMBER_OF_TRANSFORMS = 7, DFTI_COMPLEX_STORAGE = 8, DFTI_REAL_STORAGE = 9, DFTI_CONJUGATE_EVEN_STORAGE = 10, DFTI_PLACEMENT = 11, DFTI_INPUT_STRIDES = 12, DFTI_OUTPUT_STRIDES = 13, DFTI_INPUT_DISTANCE = 14, DFTI_OUTPUT_DISTANCE = 15, DFTI_WORKSPACE = 17, DFTI_ORDERING = 18, DFTI_TRANSPOSE = 19, DFTI_DESCRIPTOR_NAME = 20, DFTI_PACKED_FORMAT = 21, DFTI_COMMIT_STATUS = 22, DFTI_VERSION = 23, DFTI_NUMBER_OF_USER_THREADS = 26, DFTI_THREAD_LIMIT = 27, DFTI_DESTROY_INPUT = 28 }; enum DFTI_CONFIG_VALUE { DFTI_COMMITTED = 30, DFTI_UNCOMMITTED = 31, DFTI_COMPLEX = 32, DFTI_REAL = 33, DFTI_SINGLE = 35, DFTI_DOUBLE = 36, DFTI_COMPLEX_COMPLEX = 39, DFTI_COMPLEX_REAL = 40, DFTI_REAL_COMPLEX = 41, DFTI_REAL_REAL = 42, DFTI_INPLACE = 43, DFTI_NOT_INPLACE = 44, DFTI_ORDERED = 48, DFTI_BACKWARD_SCRAMBLED = 49, DFTI_ALLOW = 51, DFTI_AVOID = 52, DFTI_NONE = 53, DFTI_CCS_FORMAT = 54, DFTI_PACK_FORMAT = 55, DFTI_PERM_FORMAT = 56, DFTI_CCE_FORMAT = 57 }; typedef struct DFTI_DESCRIPTOR *DFTI_DESCRIPTOR_HANDLE; typedef struct DFTI_DESCRIPTOR DFTI_DESCRIPTOR; long int DftiCreateDescriptor(DFTI_DESCRIPTOR_HANDLE*, enum DFTI_CONFIG_VALUE, enum DFTI_CONFIG_VALUE, long int, ...); long int DftiCopyDescriptor(DFTI_DESCRIPTOR_HANDLE, DFTI_DESCRIPTOR_HANDLE*); long int DftiCommitDescriptor(DFTI_DESCRIPTOR_HANDLE); long int DftiComputeForward(DFTI_DESCRIPTOR_HANDLE, void*, ...); long int DftiComputeBackward(DFTI_DESCRIPTOR_HANDLE, void*, ...); long int DftiSetValue(DFTI_DESCRIPTOR_HANDLE, enum DFTI_CONFIG_PARAM, ...); long int DftiGetValue(DFTI_DESCRIPTOR_HANDLE, enum DFTI_CONFIG_PARAM, ...); long int DftiFreeDescriptor(DFTI_DESCRIPTOR_HANDLE*); char* DftiErrorMessage(long int); long int DftiErrorClass(long int, long int); long int DftiCreateDescriptor_s_1d(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, ... ); long int DftiCreateDescriptor_s_md(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, long int many, ... ); long int DftiCreateDescriptor_d_1d(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, ... ); long int DftiCreateDescriptor_d_md(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, long int many, ... ); #line 274 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" #line 54 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_trig_transforms.h" #line 38 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_trig_transforms.h" void d_init_trig_transform(int *, int *, int *, double *, int *); void d_commit_trig_transform(double *, DFTI_DESCRIPTOR_HANDLE *, int *, double *, int *); void d_forward_trig_transform(double *, DFTI_DESCRIPTOR_HANDLE *, int *, double *, int *); void d_backward_trig_transform(double *, DFTI_DESCRIPTOR_HANDLE *, int *, double *, int *); void s_init_trig_transform(int *, int *, int *, float *, int *); void s_commit_trig_transform(float *, DFTI_DESCRIPTOR_HANDLE *, int *, float *, int *); void s_forward_trig_transform(float *, DFTI_DESCRIPTOR_HANDLE *, int *, float *, int *); void s_backward_trig_transform(float *, DFTI_DESCRIPTOR_HANDLE *, int *, float *, int *); void free_trig_transform(DFTI_DESCRIPTOR_HANDLE *, int *, int *); #line 55 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_poisson.h" void d_init_helmholtz_2d(const double*, const double*, const double*, const double*, const int*, const int*, const char*, const double*, int*, double*, int*); void d_commit_helmholtz_2d(double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE *, int*, double*,int*); void d_helmholtz_2d(double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE *, int*, const double*,int*); void free_helmholtz_2d(DFTI_DESCRIPTOR_HANDLE*, int*, int*); void d_init_helmholtz_3d(const double*, const double*, const double*, const double*, const double*, const double*, const int*, const int*, const int*, const char*, const double*, int*, double*, int*); void d_commit_helmholtz_3d(double*, const double*, const double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, double*, int*); void d_helmholtz_3d(double*, const double*, const double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, const double*,int*); void free_helmholtz_3d(DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, int*); void s_init_helmholtz_2d(const float*, const float*, const float*, const float*, const int*, const int*, const char*, const float*, int*, float*, int*); void s_commit_helmholtz_2d(float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE *, int*, float*, int*); void s_helmholtz_2d(float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE *, int*, const float*, int*); void s_init_helmholtz_3d(const float*, const float*, const float*, const float*, const float*, const float*, const int*, const int*, const int*, const char*, const float*,int*,float*,int*); void s_commit_helmholtz_3d(float*, const float*, const float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, float*, int*); void s_helmholtz_3d(float*, const float*, const float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, const float*,int*); void d_init_sph_p(const double*, const double*, const double*, const double*, const int*, const int*, const double*, int*, double*, int*); void d_commit_sph_p(double*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void d_sph_p(double*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void free_sph_p(DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,int*); void d_init_sph_np(const double*, const double*, const double*, const double*, const int*, const int*, const double*, int*, double*, int*); void d_commit_sph_np(double*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void d_sph_np(double*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void free_sph_np(DFTI_DESCRIPTOR_HANDLE*,int*,int*); void s_init_sph_p(const float*, const float*, const float*, const float*, const int*, const int*, const float*, int*, float*,int*); void s_commit_sph_p(float*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); void s_sph_p(float*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); void s_init_sph_np(const float*, const float*, const float*, const float*, const int*, const int*, const float*, int*, float*,int*); void s_commit_sph_np(float*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); void s_sph_np(float*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); #line 56 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_solvers_ee.h" #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_solvers_ee.h" extern void __cdecl feastinit (int* fpm); extern void __cdecl FEASTINIT (int* fpm); extern void __cdecl dfeast_scsrev (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SCSREV (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl sfeast_sygv (const char* uplo , const int* n , const float* a , const int* lda , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SYGV (const char* uplo , const int* n , const float* a , const int* lda , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl sfeast_scsrev (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SCSREV (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl zfeast_hbgv (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , const int* klb , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HBGV (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , const int* klb , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl zfeast_hcsrev (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HCSREV (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl cfeast_hbev (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HBEV (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl zfeast_heev (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HEEV (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl zfeast_hcsrgv (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , const MKL_Complex16* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HCSRGV (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , const MKL_Complex16* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl sfeast_scsrgv (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , const float* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SCSRGV (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , const float* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl dfeast_srci (int* ijob , const int* n , MKL_Complex16* ze , double* work , MKL_Complex16* workc , double* aq , double* sq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , double* q , int* m , double* res , int* info); extern void __cdecl DFEAST_SRCI (int* ijob , const int* n , MKL_Complex16* ze , double* work , MKL_Complex16* workc , double* aq , double* sq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , double* q , int* m , double* res , int* info); extern void __cdecl sfeast_sbev (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SBEV (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl dfeast_sygv (const char* uplo , const int* n , const double* a , const int* lda , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SYGV (const char* uplo , const int* n , const double* a , const int* lda , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl cfeast_hegv (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HEGV (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl zfeast_hrci (int* ijob , const int* n , MKL_Complex16* ze , MKL_Complex16* work , MKL_Complex16* workc , MKL_Complex16* zaq , MKL_Complex16* zsq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , MKL_Complex16* q , int* m , double* res , int* info); extern void __cdecl ZFEAST_HRCI (int* ijob , const int* n , MKL_Complex16* ze , MKL_Complex16* work , MKL_Complex16* workc , MKL_Complex16* zaq , MKL_Complex16* zsq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , MKL_Complex16* q , int* m , double* res , int* info); extern void __cdecl cfeast_hrci (int* ijob , const int* n , MKL_Complex8* ze , MKL_Complex8* work , MKL_Complex8* workc , MKL_Complex8* zaq , MKL_Complex8* zsq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , MKL_Complex8* q , int* m , float* res , int* info); extern void __cdecl CFEAST_HRCI (int* ijob , const int* n , MKL_Complex8* ze , MKL_Complex8* work , MKL_Complex8* workc , MKL_Complex8* zaq , MKL_Complex8* zsq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , MKL_Complex8* q , int* m , float* res , int* info); extern void __cdecl zfeast_hegv (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HEGV (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl sfeast_srci (int* ijob , const int* n , MKL_Complex8* ze , float* work , MKL_Complex8* workc , float* aq , float* sq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , float* q , int* m , float* res , int* info); extern void __cdecl SFEAST_SRCI (int* ijob , const int* n , MKL_Complex8* ze , float* work , MKL_Complex8* workc , float* aq , float* sq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , float* q , int* m , float* res , int* info); extern void __cdecl dfeast_scsrgv (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , const double* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SCSRGV (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , const double* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl sfeast_syev (const char* uplo , const int* n , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SYEV (const char* uplo , const int* n , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl cfeast_hcsrev (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HCSREV (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl zfeast_hbev (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HBEV (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl dfeast_sbgv (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , const int* klb , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SBGV (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , const int* klb , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl cfeast_hbgv (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , const int* klb , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HBGV (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , const int* klb , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl cfeast_heev (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HEEV (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl sfeast_sbgv (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , const int* klb , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SBGV (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , const int* klb , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl cfeast_hcsrgv (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , const MKL_Complex8* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HCSRGV (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , const MKL_Complex8* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl dfeast_syev (const char* uplo , const int* n , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SYEV (const char* uplo , const int* n , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl dfeast_sbev (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SBEV (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); #line 57 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_direct_call.h" #line 58 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdarg.h" #pragma once __pragma(pack(push, 8)) __pragma(pack(pop)) #line 19 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn_types.h" typedef struct _uniPrimitive_s* dnnPrimitive_t; typedef struct _dnnLayout_s* dnnLayout_t; typedef void* dnnPrimitiveAttributes_t; typedef enum { E_SUCCESS = 0, E_INCORRECT_INPUT_PARAMETER = -1, E_UNEXPECTED_NULL_POINTER = -2, E_MEMORY_ERROR = -3, E_UNSUPPORTED_DIMENSION = -4, E_UNIMPLEMENTED = -127 } dnnError_t; typedef enum { dnnAlgorithmConvolutionGemm, dnnAlgorithmConvolutionDirect, dnnAlgorithmConvolutionFFT, dnnAlgorithmPoolingMax, dnnAlgorithmPoolingMin, dnnAlgorithmPoolingAvgExcludePadding, dnnAlgorithmPoolingAvg = dnnAlgorithmPoolingAvgExcludePadding, dnnAlgorithmPoolingAvgIncludePadding } dnnAlgorithm_t; typedef enum { dnnResourceSrc = 0, dnnResourceFrom = 0, dnnResourceDst = 1, dnnResourceTo = 1, dnnResourceFilter = 2, dnnResourceScaleShift = 2, dnnResourceBias = 3, dnnResourceMean = 3, dnnResourceDiffSrc = 4, dnnResourceDiffFilter = 5, dnnResourceDiffScaleShift = 5, dnnResourceDiffBias = 6, dnnResourceVariance = 6, dnnResourceDiffDst = 7, dnnResourceWorkspace = 8, dnnResourceMultipleSrc = 16, dnnResourceMultipleDst = 24, dnnResourceNumber = 32 } dnnResourceType_t; typedef enum { dnnBorderZeros = 0x0, dnnBorderZerosAsymm = 0x100, dnnBorderExtrapolation = 0x3 } dnnBorder_t; typedef enum { dnnUseInputMeanVariance = 0x1U, dnnUseScaleShift = 0x2U } dnnBatchNormalizationFlag_t; #line 22 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn.h" dnnError_t dnnLayoutCreate_F32( dnnLayout_t *pLayout, size_t dimension, const size_t size[], const size_t strides[]); dnnError_t dnnLayoutCreateFromPrimitive_F32( dnnLayout_t *pLayout, const dnnPrimitive_t primitive, dnnResourceType_t type); size_t dnnLayoutSerializationBufferSize_F32(); dnnError_t dnnLayoutSerialize_F32(const dnnLayout_t layout, void *buf); dnnError_t dnnLayoutDeserialize_F32(dnnLayout_t *pLayout, const void *buf); size_t dnnLayoutGetMemorySize_F32( const dnnLayout_t layout); int dnnLayoutCompare_F32( const dnnLayout_t l1, const dnnLayout_t l2); dnnError_t dnnAllocateBuffer_F32( void **pPtr, dnnLayout_t layout); dnnError_t dnnReleaseBuffer_F32( void *ptr); dnnError_t dnnLayoutDelete_F32( dnnLayout_t layout); dnnError_t dnnPrimitiveAttributesCreate_F32( dnnPrimitiveAttributes_t *attributes); dnnError_t dnnPrimitiveAttributesDestroy_F32( dnnPrimitiveAttributes_t attributes); dnnError_t dnnPrimitiveGetAttributes_F32( dnnPrimitive_t primitive, dnnPrimitiveAttributes_t *attributes); dnnError_t dnnExecute_F32( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnExecuteAsync_F32( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnWaitFor_F32( dnnPrimitive_t primitive); dnnError_t dnnDelete_F32( dnnPrimitive_t primitive); dnnError_t dnnConversionCreate_F32( dnnPrimitive_t* pConversion, const dnnLayout_t from, const dnnLayout_t to); dnnError_t dnnConversionExecute_F32( dnnPrimitive_t conversion, void *from, void *to); dnnError_t dnnSumCreate_F32( dnnPrimitive_t *pSum, dnnPrimitiveAttributes_t attributes, const size_t nSummands, dnnLayout_t layout, float *coefficients); dnnError_t dnnConcatCreate_F32( dnnPrimitive_t* pConcat, dnnPrimitiveAttributes_t attributes, const size_t nSrcTensors, dnnLayout_t *src); dnnError_t dnnSplitCreate_F32( dnnPrimitive_t *pSplit, dnnPrimitiveAttributes_t attributes, const size_t nDstTensors, dnnLayout_t layout, size_t dstChannelSize[]); dnnError_t dnnScaleCreate_F32( dnnPrimitive_t *pScale, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float alpha); dnnError_t dnnConvolutionCreateForward_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateForwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardData_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardFilter_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t dstSize[]); dnnError_t dnnGroupsConvolutionCreateForward_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateForwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardData_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardFilter_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t dstSize[]); dnnError_t dnnReLUCreateForward_F32( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float negativeSlope); dnnError_t dnnReLUCreateBackward_F32( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, float negativeSlope); dnnError_t dnnLRNCreateForward_F32( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, size_t kernel_size, float alpha, float beta, float k); dnnError_t dnnLRNCreateBackward_F32( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, size_t kernel_size, float alpha, float beta, float k); dnnError_t dnnBatchNormalizationCreateForward_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps); dnnError_t dnnBatchNormalizationCreateBackwardScaleShift_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps); dnnError_t dnnBatchNormalizationCreateBackwardData_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps); dnnError_t dnnBatchNormalizationCreateForward_v2_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps, unsigned int flags); dnnError_t dnnBatchNormalizationCreateBackward_v2_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps, unsigned int flags); dnnError_t dnnPoolingCreateForward_F32( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnPoolingCreateBackward_F32( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnInnerProductCreateForward_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateForwardBias_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardData_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardFilter_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardBias_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t dstSize[]); dnnError_t dnnLayoutCreate_F64 ( dnnLayout_t *pLayout, size_t dimension, const size_t size[], const size_t strides[]); dnnError_t dnnLayoutCreateFromPrimitive_F64( dnnLayout_t *pLayout, const dnnPrimitive_t primitive, dnnResourceType_t type); size_t dnnLayoutSerializationBufferSize_F64(); dnnError_t dnnLayoutSerialize_F64(const dnnLayout_t layout, void *buf); dnnError_t dnnLayoutDeserialize_F64(dnnLayout_t *pLayout, const void *buf); size_t dnnLayoutGetMemorySize_F64( const dnnLayout_t layout); int dnnLayoutCompare_F64( const dnnLayout_t l1, const dnnLayout_t l2); dnnError_t dnnAllocateBuffer_F64( void **pPtr, dnnLayout_t layout); dnnError_t dnnReleaseBuffer_F64( void *ptr); dnnError_t dnnLayoutDelete_F64( dnnLayout_t layout); dnnError_t dnnPrimitiveAttributesCreate_F64( dnnPrimitiveAttributes_t *attributes); dnnError_t dnnPrimitiveAttributesDestroy_F64( dnnPrimitiveAttributes_t attributes); dnnError_t dnnPrimitiveGetAttributes_F64( dnnPrimitive_t primitive, dnnPrimitiveAttributes_t *attributes); dnnError_t dnnExecute_F64( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnExecuteAsync_F64( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnWaitFor_F64( dnnPrimitive_t primitive); dnnError_t dnnDelete_F64( dnnPrimitive_t primitive); dnnError_t dnnConversionCreate_F64( dnnPrimitive_t* pConversion, const dnnLayout_t from, const dnnLayout_t to); dnnError_t dnnConversionExecute_F64( dnnPrimitive_t conversion, void *from, void *to); dnnError_t dnnSumCreate_F64( dnnPrimitive_t *pSum, dnnPrimitiveAttributes_t attributes, const size_t nSummands, dnnLayout_t layout, double *coefficients); dnnError_t dnnConcatCreate_F64( dnnPrimitive_t* pConcat, dnnPrimitiveAttributes_t attributes, const size_t nSrcTensors, dnnLayout_t *src); dnnError_t dnnSplitCreate_F64( dnnPrimitive_t *pSplit, dnnPrimitiveAttributes_t attributes, const size_t nDstTensors, dnnLayout_t layout, size_t dstChannelSize[]); dnnError_t dnnScaleCreate_F64( dnnPrimitive_t *pScale, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double alpha); dnnError_t dnnConvolutionCreateForward_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateForwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardData_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardFilter_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t dstSize[]); dnnError_t dnnGroupsConvolutionCreateForward_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateForwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardData_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardFilter_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t dstSize[]); dnnError_t dnnReLUCreateForward_F64( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double negativeSlope); dnnError_t dnnReLUCreateBackward_F64( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, double negativeSlope); dnnError_t dnnLRNCreateForward_F64( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, size_t kernel_size, double alpha, double beta, double k); dnnError_t dnnLRNCreateBackward_F64( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, size_t kernel_size, double alpha, double beta, double k); dnnError_t dnnBatchNormalizationCreateForward_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps); dnnError_t dnnBatchNormalizationCreateBackwardScaleShift_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps); dnnError_t dnnBatchNormalizationCreateBackwardData_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps); dnnError_t dnnBatchNormalizationCreateForward_v2_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps, unsigned int flags); dnnError_t dnnBatchNormalizationCreateBackward_v2_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps, unsigned int flags); dnnError_t dnnPoolingCreateForward_F64( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnPoolingCreateBackward_F64( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnInnerProductCreateForward_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateForwardBias_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardData_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardFilter_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardBias_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t dstSize[]); #line 59 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_compact.h" MKL_COMPACT_PACK mkl_get_format_compact( void ); int mkl_sget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_sgepack_compact( MKL_LAYOUT layout, int rows, int columns, const float * const *a, int lda, float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_sgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, float * const *a, int lda, const float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_sgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, float alpha, const float *ap, int ldap, const float *bp, int ldbp, float beta, float *cp, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_strsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, float alpha, const float *ap, int ldap, float *bp, int ldbp, MKL_COMPACT_PACK format, int nm ); int mkl_dget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_dgepack_compact( MKL_LAYOUT layout, int rows, int columns, const double * const *a, int lda, double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_dgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, double * const *a, int lda, const double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_dgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, double alpha, const double *a, int ldap, const double *b, int ldbp, double beta, double *c, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_dtrsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, double alpha, const double *a, int ldap, double *b, int ldbp, MKL_COMPACT_PACK format, int nm ); int mkl_cget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_cgepack_compact( MKL_LAYOUT layout, int rows, int columns, const MKL_Complex8 * const *a, int lda, float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_cgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, MKL_Complex8 * const *a, int lda, const float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_cgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, const MKL_Complex8 *alpha, const float *a, int ldap, const float *b, int ldbp, const MKL_Complex8 *beta, float *c, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_ctrsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, const MKL_Complex8 *alpha, const float *a, int ldap, float *b, int ldbp, MKL_COMPACT_PACK format, int nm ); int mkl_zget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_zgepack_compact( MKL_LAYOUT layout, int rows, int columns, const MKL_Complex16 * const *a, int lda, double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_zgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, MKL_Complex16 * const *a, int lda, const double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_zgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, const MKL_Complex16 *alpha, const double *a, int ldap, const double *b, int ldbp, const MKL_Complex16 *beta, double *c, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_ztrsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, const MKL_Complex16 *alpha, const double *a, int ldap, double *b, int ldbp, MKL_COMPACT_PACK format, int nm ); void mkl_cgetrinp_compact( MKL_LAYOUT layout, int n, float* ap, int ldap, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dgetrinp_compact( MKL_LAYOUT layout, int n, double* ap, int ldap, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_sgetrinp_compact( MKL_LAYOUT layout, int n, float* ap, int ldap, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zgetrinp_compact( MKL_LAYOUT layout, int n, double* ap, int ldap, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_cgetrfnp_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dgetrfnp_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_sgetrfnp_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zgetrfnp_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_cpotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dpotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_spotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zpotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_cgeqrf_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, float* taup, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dgeqrf_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, double* taup, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_sgeqrf_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, float* taup, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zgeqrf_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, double* taup, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); #line 60 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Checking include with compiler flags var CPPFLAGS [] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef struct _MKL_Complex8 { float real; float imag; } MKL_Complex8; typedef struct _MKL_Complex16 { double real; double imag; } MKL_Complex16; typedef struct { int MajorVersion; int MinorVersion; int UpdateVersion; char * ProductStatus; char * Build; char * Processor; char * Platform; } MKLVersion; #line 65 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 78 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 87 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 103 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 135 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 143 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef enum { MKL_ROW_MAJOR = 101, MKL_COL_MAJOR = 102 } MKL_LAYOUT; typedef enum { MKL_NOTRANS = 111, MKL_TRANS = 112, MKL_CONJTRANS = 113 } MKL_TRANSPOSE; typedef enum { MKL_UPPER = 121, MKL_LOWER = 122 } MKL_UPLO; typedef enum { MKL_NONUNIT = 131, MKL_UNIT = 132 } MKL_DIAG; typedef enum { MKL_LEFT = 141, MKL_RIGHT = 142 } MKL_SIDE; typedef enum { MKL_COMPACT_SSE = 181, MKL_COMPACT_AVX = 182, MKL_COMPACT_AVX512 = 183 } MKL_COMPACT_PACK; #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" #line 35 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" __declspec(deprecated) void mkl_scsrmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scsrsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scscmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scscsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scoomv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scoosv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_sdiamv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sdiasv (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiagemv(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiasymv(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sskymv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sskysv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void mkl_sbsrmv (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sbsrsv(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scsrsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scscmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scscsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scoomm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scoosm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiamm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiasm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskysm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskymm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrsm(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSRSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSCMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSCSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCOOMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCOOSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SDIAMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SDIASV (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIAGEMV(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIASYMV(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SSKYMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SSKYSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void MKL_SBSRMV (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SBSRSV(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIAMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIASM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYSM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRSM(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_dcsrmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcsrsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcscmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcscsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcoomv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcoosv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_ddiamv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_ddiasv (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiagemv(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiasymv(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_dskymv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dskysv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void mkl_dbsrmv (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dbsrsv(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcsrsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoomm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoosm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiamm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiasm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskysm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskymm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrsm(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSRSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSCMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSCSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCOOMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCOOSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DDIAMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DDIASV (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIAGEMV(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIASYMV(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DSKYMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DSKYSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void MKL_DBSRMV (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DBSRSV(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIAMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIASM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYSM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRSM(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ccsrmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoomv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiamv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasv (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiagemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskymv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskysv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccsrsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoosm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiasm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskysm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASV (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIASM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoomv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiamv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasv (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiagemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskymv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskysv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoosm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiasm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskysm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASV (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIASM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_dcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_dcsrcoo(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_ddnscsr(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_dcsrcsc(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_dcsrdia(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_dcsrsky(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_scsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_scsrcoo(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_sdnscsr(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_scsrcsc(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_scsrdia(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_scsrsky(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_ccsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_ccsrcoo(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_cdnscsr(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_ccsrcsc(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_ccsrdia(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_ccsrsky(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_zcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_zcsrcoo(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_zdnscsr(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_zcsrcsc(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_zcsrdia(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_zcsrsky(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_DCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_DCSRCOO(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_DDNSCSR(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_DCSRCSC(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_DCSRDIA(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_DCSRSKY(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_SCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_SCSRCOO(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_SDNSCSR(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_SCSRCSC(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_SCSRDIA(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_SCSRSKY(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_CCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_CCSRCOO(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_CDNSCSR(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_CCSRCSC(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_CCSRDIA(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_CCSRSKY(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_ZCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_ZCSRCOO(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_ZDNSCSR(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_ZCSRCSC(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_ZCSRDIA(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_ZCSRSKY(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_dcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_dcsrmultd(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void mkl_dcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultd(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void mkl_scsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void mkl_ccsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void mkl_zcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTD(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void MKL_DCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTD(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void MKL_SCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void MKL_CCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void MKL_ZCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); typedef enum { SPARSE_STATUS_SUCCESS = 0, SPARSE_STATUS_NOT_INITIALIZED = 1, SPARSE_STATUS_ALLOC_FAILED = 2, SPARSE_STATUS_INVALID_VALUE = 3, SPARSE_STATUS_EXECUTION_FAILED = 4, SPARSE_STATUS_INTERNAL_ERROR = 5, SPARSE_STATUS_NOT_SUPPORTED = 6 } sparse_status_t; typedef enum { SPARSE_OPERATION_NON_TRANSPOSE = 10, SPARSE_OPERATION_TRANSPOSE = 11, SPARSE_OPERATION_CONJUGATE_TRANSPOSE = 12 } sparse_operation_t; typedef enum { SPARSE_MATRIX_TYPE_GENERAL = 20, SPARSE_MATRIX_TYPE_SYMMETRIC = 21, SPARSE_MATRIX_TYPE_HERMITIAN = 22, SPARSE_MATRIX_TYPE_TRIANGULAR = 23, SPARSE_MATRIX_TYPE_DIAGONAL = 24, SPARSE_MATRIX_TYPE_BLOCK_TRIANGULAR = 25, SPARSE_MATRIX_TYPE_BLOCK_DIAGONAL = 26 } sparse_matrix_type_t; typedef enum { SPARSE_INDEX_BASE_ZERO = 0, SPARSE_INDEX_BASE_ONE = 1 } sparse_index_base_t; typedef enum { SPARSE_FILL_MODE_LOWER = 40, SPARSE_FILL_MODE_UPPER = 41, SPARSE_FILL_MODE_FULL = 42 } sparse_fill_mode_t; typedef enum { SPARSE_DIAG_NON_UNIT = 50, SPARSE_DIAG_UNIT = 51 } sparse_diag_type_t; typedef enum { SPARSE_LAYOUT_ROW_MAJOR = 101, SPARSE_LAYOUT_COLUMN_MAJOR = 102 } sparse_layout_t; typedef enum { SPARSE_VERBOSE_OFF = 70, SPARSE_VERBOSE_BASIC = 71, SPARSE_VERBOSE_EXTENDED = 72 } verbose_mode_t; typedef enum { SPARSE_MEMORY_NONE = 80, SPARSE_MEMORY_AGGRESSIVE = 81 } sparse_memory_usage_t; typedef enum { SPARSE_STAGE_FULL_MULT = 90, SPARSE_STAGE_NNZ_COUNT = 91, SPARSE_STAGE_FINALIZE_MULT = 92, SPARSE_STAGE_FULL_MULT_NO_VAL = 93, SPARSE_STAGE_FINALIZE_MULT_NO_VAL = 94 } sparse_request_t; struct sparse_matrix; typedef struct sparse_matrix *sparse_matrix_t; struct matrix_descr { sparse_matrix_type_t type; sparse_fill_mode_t mode; sparse_diag_type_t diag; }; sparse_status_t mkl_sparse_s_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_copy( const sparse_matrix_t source, struct matrix_descr descr, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_destroy( sparse_matrix_t A ); sparse_status_t mkl_sparse_get_error_info( sparse_matrix_t A, int *info ); sparse_status_t mkl_sparse_convert_csr ( const sparse_matrix_t source, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_convert_bsr ( const sparse_matrix_t source, int block_size, sparse_layout_t block_layout, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_s_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_set_value( sparse_matrix_t A, int row, int col, float value ); sparse_status_t mkl_sparse_d_set_value( sparse_matrix_t A, int row, int col, double value ); sparse_status_t mkl_sparse_c_set_value( sparse_matrix_t A, int row, int col, MKL_Complex8 value ); sparse_status_t mkl_sparse_z_set_value( sparse_matrix_t A, int row, int col, MKL_Complex16 value ); sparse_status_t mkl_sparse_set_verbose_mode ( verbose_mode_t verbose ); sparse_status_t mkl_sparse_set_mv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_mm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_sv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_sm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_memory_hint ( sparse_matrix_t A, sparse_memory_usage_t policy ); sparse_status_t mkl_sparse_optimize ( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_mv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y ); sparse_status_t mkl_sparse_d_mv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y ); sparse_status_t mkl_sparse_c_mv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_mv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_trsv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float *y ); sparse_status_t mkl_sparse_d_trsv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double *y ); sparse_status_t mkl_sparse_c_trsv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_trsv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_mm( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float beta, float *y, int ldy ); sparse_status_t mkl_sparse_d_mm( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double beta, double *y, int ldy ); sparse_status_t mkl_sparse_c_mm( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 beta, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_mm( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 beta, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_trsm ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float *y, int ldy ); sparse_status_t mkl_sparse_d_trsm ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double *y, int ldy ); sparse_status_t mkl_sparse_c_trsm ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_trsm ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_add( sparse_operation_t operation, const sparse_matrix_t A, float alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_d_add( sparse_operation_t operation, const sparse_matrix_t A, double alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_c_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_z_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_spmm( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sp2m ( sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, sparse_request_t request, sparse_matrix_t *C ); sparse_status_t mkl_sparse_syrk ( sparse_operation_t operation, const sparse_matrix_t A, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sypr ( sparse_operation_t transA, const sparse_matrix_t A, const sparse_matrix_t B, struct matrix_descr descrB, sparse_matrix_t *C, sparse_request_t request ); sparse_status_t mkl_sparse_s_syprd ( const sparse_operation_t op, const sparse_matrix_t A, float *B, const sparse_layout_t layoutB, const int ldb, float alpha, float beta, float *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_d_syprd ( const sparse_operation_t op, const sparse_matrix_t A, double *B, const sparse_layout_t layoutB, const int ldb, double alpha, double beta, double *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_c_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex8 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_z_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex16 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_order( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, float *C, int ldc ); sparse_status_t mkl_sparse_d_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, double *C, int ldc ); sparse_status_t mkl_sparse_c_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex8 *C, int ldc ); sparse_status_t mkl_sparse_z_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex16 *C, int ldc ); sparse_status_t mkl_sparse_d_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const double alpha, const double beta, double *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_s_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const float alpha, const float beta, float *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_z_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex16 alpha, const MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_c_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex8 alpha, const MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_set_symgs_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_d_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x, double *y); sparse_status_t mkl_sparse_d_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x); sparse_status_t mkl_sparse_set_dotmv_hint( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expectedCalls ); sparse_status_t mkl_sparse_d_dotmv( sparse_operation_t transA, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y, double *d ); sparse_status_t mkl_sparse_s_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x, float *y); sparse_status_t mkl_sparse_s_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x); sparse_status_t mkl_sparse_s_dotmv( sparse_operation_t transA, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y, float *d ); sparse_status_t mkl_sparse_c_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x, MKL_Complex8 *y); sparse_status_t mkl_sparse_c_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x); sparse_status_t mkl_sparse_c_dotmv( sparse_operation_t transA, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y, MKL_Complex8 *d ); sparse_status_t mkl_sparse_z_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x, MKL_Complex16 *y); sparse_status_t mkl_sparse_z_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x); sparse_status_t mkl_sparse_z_dotmv( sparse_operation_t transA, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y, MKL_Complex16 *d ); sparse_status_t mkl_sparse_s_syrkd( sparse_operation_t operation, const sparse_matrix_t A, float alpha, float beta, float *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_d_syrkd( sparse_operation_t operation, const sparse_matrix_t A, double alpha, double beta, double *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_c_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_z_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, sparse_layout_t layout, int ldc ); #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Found header files ['mkl.h', 'mkl_spblas.h'] in [] Popping language C ================================================================================ TEST checkSharedLibrary from config.packages.mkl_sparse_sp2m(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:799) TESTING: checkSharedLibrary from config.packages.mkl_sparse_sp2m(config/BuildSystem/config/package.py:799) By default we don't care about checking if the library is shared Popping language C Pushing language C ================================================================================ TEST checkDependencies from config.packages.mkl_sparse_optimize(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:721) TESTING: checkDependencies from config.packages.mkl_sparse_optimize(config/BuildSystem/config/package.py:721) ================================================================================ TEST configureLibrary from config.packages.mkl_sparse_optimize(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/mkl_sparse_optimize.py:44) TESTING: configureLibrary from config.packages.mkl_sparse_optimize(config/BuildSystem/config/packages/mkl_sparse_optimize.py:44) ================================================================================== Checking for a functional mkl_sparse_optimize Checking for library in Compiler specific search MKL_SPARSE_OPTIMIZE: [] ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [mkl_sparse_optimize mkl_sparse_s_create_bsr] in library [] ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char mkl_sparse_optimize(); static void _check_mkl_sparse_optimize() { mkl_sparse_optimize(); } char mkl_sparse_s_create_bsr(); static void _check_mkl_sparse_s_create_bsr() { mkl_sparse_s_create_bsr(); } int main() { _check_mkl_sparse_optimize(); _check_mkl_sparse_s_create_bsr();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Popping language C Checking for headers Compiler specific search MKL_SPARSE_OPTIMIZE: [] Pushing language C ================================================================================ TEST checkInclude from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:86) TESTING: checkInclude from config.headers(config/BuildSystem/config/headers.py:86) Checks if a particular include file can be found along particular include paths Checking for header files ['mkl.h', 'mkl_spblas.h'] in [] Checking include with compiler flags var CPPFLAGS [] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 32 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_version.h" #line 16 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_version.h" #line 23 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_version.h" #line 38 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef struct _MKL_Complex8 { float real; float imag; } MKL_Complex8; typedef struct _MKL_Complex16 { double real; double imag; } MKL_Complex16; typedef struct { int MajorVersion; int MinorVersion; int UpdateVersion; char * ProductStatus; char * Build; char * Processor; char * Platform; } MKLVersion; #line 65 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 78 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 87 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 103 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 135 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 143 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef enum { MKL_ROW_MAJOR = 101, MKL_COL_MAJOR = 102 } MKL_LAYOUT; typedef enum { MKL_NOTRANS = 111, MKL_TRANS = 112, MKL_CONJTRANS = 113 } MKL_TRANSPOSE; typedef enum { MKL_UPPER = 121, MKL_LOWER = 122 } MKL_UPLO; typedef enum { MKL_NONUNIT = 131, MKL_UNIT = 132 } MKL_DIAG; typedef enum { MKL_LEFT = 141, MKL_RIGHT = 142 } MKL_SIDE; typedef enum { MKL_COMPACT_SSE = 181, MKL_COMPACT_AVX = 182, MKL_COMPACT_AVX512 = 183 } MKL_COMPACT_PACK; #line 39 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_blas.h" void XERBLA(const char *srname, const int *info, const int lsrname); int LSAME(const char *ca, const char *cb, const int lca, const int lcb); float SCABS1(const MKL_Complex8 *c); float SASUM(const int *n, const float *x, const int *incx); void SAXPY(const int *n, const float *alpha, const float *x, const int *incx, float *y, const int *incy); void SAXPBY(const int *n, const float *alpha, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SAXPYI(const int *nz, const float *a, const float *x, const int *indx,float *y); float SCASUM(const int *n, const MKL_Complex8 *x, const int *incx); float SCNRM2(const int *n, const MKL_Complex8 *x, const int *incx); void SCOPY(const int *n, const float *x, const int *incx, float *y, const int *incy); float SDOT(const int *n, const float *x, const int *incx, const float *y, const int *incy); float SDSDOT(const int *n, const float *sb, const float *x, const int *incx, const float *y, const int *incy); float SDOTI(const int *nz, const float *x, const int *indx, const float *y); void SGTHR(const int *nz, const float *y, float *x, const int *indx); void SGTHRZ(const int *nz, float *y, float *x, const int *indx); float SNRM2(const int *n, const float *x, const int *incx); void SROT(const int *n, float *x, const int *incx, float *y, const int *incy, const float *c, const float *s); void SROTG(float *a,float *b,float *c,float *s); void SROTI(const int *nz, float *x, const int *indx, float *y, const float *c, const float *s); void SROTM(const int *n, float *x, const int *incx, float *y, const int *incy, const float *param); void SROTMG(float *d1, float *d2, float *x1, const float *y1, float *param); void SSCAL(const int *n, const float *a, float *x, const int *incx); void SSCTR(const int *nz, const float *x, const int *indx, float *y); void SSWAP(const int *n, float *x, const int *incx, float *y, const int *incy); int ISAMAX(const int *n, const float *x, const int *incx); int ISAMIN(const int *n, const float *x, const int *incx); void CAXPY(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void CAXPBY(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CAXPYI(const int *nz, const MKL_Complex8 *a, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void CCOPY(const int *n, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void CDOTC(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void CDOTCI(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void CDOTU(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void CDOTUI(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void CGTHR(const int *nz, const MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void CGTHRZ(const int *nz, MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void CROTG(MKL_Complex8 *a, const MKL_Complex8 *b, float *c, MKL_Complex8 *s); void CSCAL(const int *n, const MKL_Complex8 *a, MKL_Complex8 *x, const int *incx); void CSCTR(const int *nz, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void CSROT(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy, const float *c, const float *s); void CSSCAL(const int *n, const float *a, MKL_Complex8 *x, const int *incx); void CSWAP(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); int ICAMAX(const int *n, const MKL_Complex8 *x, const int *incx); int ICAMIN(const int *n, const MKL_Complex8 *x, const int *incx); double DCABS1(const MKL_Complex16 *z); double DASUM(const int *n, const double *x, const int *incx); void DAXPY(const int *n, const double *alpha, const double *x, const int *incx, double *y, const int *incy); void DAXPBY(const int *n, const double *alpha, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DAXPYI(const int *nz, const double *a, const double *x, const int *indx, double *y); void DCOPY(const int *n, const double *x, const int *incx, double *y, const int *incy); double DDOT(const int *n, const double *x, const int *incx, const double *y, const int *incy); double DSDOT(const int *n, const float *x, const int *incx, const float *y, const int *incy); double DDOTI(const int *nz, const double *x, const int *indx, const double *y); void DGTHR(const int *nz, const double *y, double *x, const int *indx); void DGTHRZ(const int *nz, double *y, double *x, const int *indx); double DNRM2(const int *n, const double *x, const int *incx); void DROT(const int *n, double *x, const int *incx, double *y, const int *incy, const double *c, const double *s); void DROTG(double *a,double *b,double *c,double *s); void DROTI(const int *nz, double *x, const int *indx, double *y, const double *c, const double *s); void DROTM(const int *n, double *x, const int *incx, double *y, const int *incy, const double *param); void DROTMG(double *d1, double *d2, double *x1, const double *y1, double *param); void DSCAL(const int *n, const double *a, double *x, const int *incx); void DSCTR(const int *nz, const double *x, const int *indx, double *y); void DSWAP(const int *n, double *x, const int *incx, double *y, const int *incy); double DZASUM(const int *n, const MKL_Complex16 *x, const int *incx); double DZNRM2(const int *n, const MKL_Complex16 *x, const int *incx); int IDAMAX(const int *n, const double *x, const int *incx); int IDAMIN(const int *n, const double *x, const int *incx); void ZAXPY(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void ZAXPBY(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZAXPYI(const int *nz, const MKL_Complex16 *a, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void ZCOPY(const int *n, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void ZDOTC(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void ZDOTCI(MKL_Complex16 *pres,const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void ZDOTU(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void ZDOTUI(MKL_Complex16 *pres, const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void ZDROT(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy, const double *c, const double *s); void ZDSCAL(const int *n, const double *a, MKL_Complex16 *x, const int *incx); void ZGTHR(const int *nz, const MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void ZGTHRZ(const int *nz, MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void ZROTG(MKL_Complex16 *a, const MKL_Complex16 *b, double *c, MKL_Complex16 *s); void ZSCAL(const int *n, const MKL_Complex16 *a, MKL_Complex16 *x, const int *incx); void ZSCTR(const int *nz, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void ZSWAP(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); int IZAMAX(const int *n, const MKL_Complex16 *x, const int *incx); int IZAMIN(const int *n,const MKL_Complex16 *x, const int *incx); void SGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SGEMV(const char *trans, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SGER(const int *m, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void SSBMV(const char *uplo, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SSPMV(const char *uplo, const int *n, const float *alpha, const float *ap, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SSPR(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *ap); void SSPR2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *ap); void SSYMV(const char *uplo, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SSYR(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *a, const int *lda); void SSYR2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void STBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void STBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void STPMV(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void STPSV(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void STRMV(const char *uplo, const char *transa, const char *diag, const int *n, const float *a, const int *lda, float *b, const int *incx); void STRSV(const char *uplo, const char *trans, const char *diag, const int *n, const float *a, const int *lda, float *x, const int *incx); void SGEM2VU(const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x1, const int *incx1, const float *x2, const int *incx2, const float *beta, float *y1, const int *incy1, float *y2, const int *incy2); void CGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CGEMV(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CGERC(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void CGERU(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void CHBMV(const char *uplo, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CHEMV(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CHER(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *a, const int *lda); void CHER2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void CHPMV(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *ap, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CHPR(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *ap); void CHPR2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *ap); void CTBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void CTBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void CTPMV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void CTPSV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void CTRMV(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *incx); void CTRSV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void CGEM2VC(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x1, const int *incx1, const MKL_Complex8 *x2, const int *incx2, const MKL_Complex8 *beta, MKL_Complex8 *y1, const int *incy1, MKL_Complex8 *y2, const int *incy2); void SCGEMV(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void DGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DGEMV(const char *trans, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DGER(const int *m, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void DSBMV(const char *uplo, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DSPMV(const char *uplo, const int *n, const double *alpha, const double *ap, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DSPR(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *ap); void DSPR2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *ap); void DSYMV(const char *uplo, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DSYR(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *a, const int *lda); void DSYR2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void DTBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void DTBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void DTPMV(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void DTPSV(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void DTRMV(const char *uplo, const char *transa, const char *diag, const int *n, const double *a, const int *lda, double *b, const int *incx); void DTRSV(const char *uplo, const char *trans, const char *diag, const int *n, const double *a, const int *lda, double *x, const int *incx); void DGEM2VU(const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x1, const int *incx1, const double *x2, const int *incx2, const double *beta, double *y1, const int *incy1, double *y2, const int *incy2); void ZGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZGEMV(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZGERC(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void ZGERU(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void ZHBMV(const char *uplo, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZHEMV(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZHER(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *a, const int *lda); void ZHER2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void ZHPMV(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *ap, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZHPR(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *ap); void ZHPR2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *ap); void ZTBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ZTBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ZTPMV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ZTPSV(const char *uplo, const char *trans, const char *diag, const int *n, MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ZTRMV(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *incx); void ZTRSV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ZGEM2VC(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x1, const int *incx1, const MKL_Complex16 *x2, const int *incx2, const MKL_Complex16 *beta, MKL_Complex16 *y1, const int *incy1, MKL_Complex16 *y2, const int *incy2); void DZGEMV(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void SGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); float* SGEMM_ALLOC(const char *identifier, const int *m, const int *n, const int *k); void SGEMM_PACK(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const float *alpha, const float *src, const int *ld, float *dest); void SGEMM_COMPUTE(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SGEMM_FREE(float *mat); void SGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const float *alpha_array, const float **a_array, const int *lda_array, const float **b_array, const int *ldb_array, const float *beta_array, float **c_array, const int *ldc_array, const int *group_count, const int *group_size); void SGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SSYMM(const char *side, const char *uplo, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SSYRK(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *beta, float *c, const int *ldc); void STRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void STRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void STRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const float *alpha_array, const float **a_array, const int *lda_array, float **b_array, const int *ldb, const int *group_count, const int *group_size); void CGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void SCGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CGEMM3M(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CGEMM3M_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void CGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CHEMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CHER2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const float *beta, MKL_Complex8 *c, const int *ldc); void CHERK(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const MKL_Complex8 *a, const int *lda, const float *beta, MKL_Complex8 *c, const int *ldc); void CSYMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CSYRK(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CTRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void CTRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void CTRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, MKL_Complex8 **b_array, const int *ldb, const int *group_count, const int *group_size); void DGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); double* DGEMM_ALLOC(const char *identifier, const int *m, const int *n, const int *k); void DGEMM_PACK(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const double *alpha, const double *src, const int *ld, double *dest); void DGEMM_COMPUTE(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void DGEMM_FREE(double *mat); void DGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const double *alpha_array, const double **a_array, const int *lda_array, const double **b_array, const int *ldb_array, const double *beta_array, double **c_array, const int *ldc_array, const int *group_count, const int *group_size); void DGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, double *beta, double *c, const int *ldc); void DSYMM(const char *side, const char *uplo, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void DSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, double *beta, double *c, const int *ldc); void DSYRK(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *beta, double *c, const int *ldc); void DTRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void DTRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void DTRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const double *alpha_array, const double **a_array, const int *lda_array, double **b_array, const int *ldb, const int *group_count, const int *group_size); void ZGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void DZGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZGEMM3M(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZGEMM3M_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void ZGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZHEMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZHER2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const double *beta, MKL_Complex16 *c, const int *ldc); void ZHERK(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const MKL_Complex16 *a, const int *lda, const double *beta, MKL_Complex16 *c, const int *ldc); void ZSYMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZSYRK(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZTRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ZTRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ZTRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, MKL_Complex16 **b_array, const int *ldb, const int *group_count, const int *group_size); void GEMM_S8U8S32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const char *a, const int *lda, const char *ao, const unsigned char *b, const int *ldb, const char *bo, const float *beta, int *c, const int *ldc, const int *co); void GEMM_S16S16S32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const short *a, const int *lda, const short *ao, const short *b, const int *ldb, const short *bo, const float *beta, int *c, const int *ldc, const int *co); void xerbla(const char *srname, const int *info, const int lsrname); int lsame(const char *ca, const char *cb, const int lca, const int lcb); float scabs1(const MKL_Complex8 *c); float sasum(const int *n, const float *x, const int *incx); void saxpy(const int *n, const float *alpha, const float *x, const int *incx, float *y, const int *incy); void saxpby(const int *n, const float *alpha, const float *x, const int *incx, const float *beta, float *y, const int *incy); void saxpyi(const int *nz, const float *a, const float *x, const int *indx, float *y); float scasum(const int *n, const MKL_Complex8 *x, const int *incx); float scnrm2(const int *n, const MKL_Complex8 *x, const int *incx); void scopy(const int *n, const float *x, const int *incx, float *y, const int *incy); float sdot(const int *n, const float *x, const int *incx, const float *y, const int *incy); float sdoti(const int *nz, const float *x, const int *indx, const float *y); float sdsdot(const int *n, const float *sb, const float *x, const int *incx, const float *y, const int *incy); void sgthr(const int *nz, const float *y, float *x, const int *indx); void sgthrz(const int *nz, float *y, float *x, const int *indx); float snrm2(const int *n, const float *x, const int *incx); void srot(const int *n, float *x, const int *incx, float *y, const int *incy, const float *c, const float *s); void srotg(float *a,float *b,float *c,float *s); void sroti(const int *nz, float *x, const int *indx, float *y, const float *c, const float *s); void srotm(const int *n, float *x, const int *incx, float *y, const int *incy, const float *param); void srotmg(float *d1, float *d2, float *x1, const float *y1, float *param); void sscal(const int *n, const float *a, float *x, const int *incx); void ssctr(const int *nz, const float *x, const int *indx, float *y); void sswap(const int *n, float *x, const int *incx, float *y, const int *incy); int isamax(const int *n, const float *x, const int *incx); int isamin(const int *n, const float *x, const int *incx); void caxpy(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void caxpby(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void caxpyi(const int *nz, const MKL_Complex8 *a, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void ccopy(const int *n, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void cdotc(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void cdotci(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void cdotu(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void cdotui(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void cgthr(const int *nz, const MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void cgthrz(const int *nz, MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void crotg(MKL_Complex8 *a, const MKL_Complex8 *b, float *c, MKL_Complex8 *s); void cscal(const int *n, const MKL_Complex8 *a, MKL_Complex8 *x, const int *incx); void csctr(const int *nz, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void csrot(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy, const float *c, const float *s); void csscal(const int *n, const float *a, MKL_Complex8 *x, const int *incx); void cswap(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); int icamax(const int *n, const MKL_Complex8 *x, const int *incx); int icamin(const int *n, const MKL_Complex8 *x, const int *incx); double dcabs1(const MKL_Complex16 *z); double dasum(const int *n, const double *x, const int *incx); void daxpy(const int *n, const double *alpha, const double *x, const int *incx, double *y, const int *incy); void daxpby(const int *n, const double *alpha, const double *x, const int *incx, const double *beta, double *y, const int *incy); void daxpyi(const int *nz, const double *a, const double *x, const int *indx, double *y); void dcopy(const int *n, const double *x, const int *incx, double *y, const int *incy); double ddot(const int *n, const double *x, const int *incx, const double *y, const int *incy); double dsdot(const int *n, const float *x, const int *incx, const float *y, const int *incy); double ddoti(const int *nz, const double *x, const int *indx, const double *y); void dgthr(const int *nz, const double *y, double *x, const int *indx); void dgthrz(const int *nz, double *y, double *x, const int *indx); double dnrm2(const int *n, const double *x, const int *incx); void drot(const int *n, double *x, const int *incx, double *y, const int *incy, const double *c, const double *s); void drotg(double *a, double *b, double *c, double *s); void droti(const int *nz, double *x, const int *indx, double *y, const double *c, const double *s); void drotm(const int *n, double *x, const int *incx, double *y, const int *incy, const double *param); void drotmg(double *d1, double *d2, double *x1, const double *y1, double *param); void dscal(const int *n, const double *a, double *x, const int *incx); void dsctr(const int *nz, const double *x, const int *indx, double *y); void dswap(const int *n, double *x, const int *incx, double *y, const int *incy); double dzasum(const int *n, const MKL_Complex16 *x, const int *incx); double dznrm2(const int *n, const MKL_Complex16 *x, const int *incx); int idamax(const int *n, const double *x, const int *incx); int idamin(const int *n, const double *x, const int *incx); void zaxpy(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void zaxpby(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zaxpyi(const int *nz, const MKL_Complex16 *a, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void zcopy(const int *n, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void zdotc(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void zdotci(MKL_Complex16 *pres, const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void zdotu(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void zdotui(MKL_Complex16 *pres, const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void zdrot(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy, const double *c, const double *s); void zdscal(const int *n, const double *a, MKL_Complex16 *x, const int *incx); void zgthr(const int *nz, const MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void zgthrz(const int *nz, MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void zrotg(MKL_Complex16 *a, const MKL_Complex16 *b, double *c, MKL_Complex16 *s); void zscal(const int *n, const MKL_Complex16 *a, MKL_Complex16 *x, const int *incx); void zsctr(const int *nz, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void zswap(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); int izamax(const int *n, const MKL_Complex16 *x, const int *incx); int izamin(const int *n, const MKL_Complex16 *x, const int *incx); void sgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sgemv(const char *trans, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sger(const int *m, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void ssbmv(const char *uplo, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sspmv(const char *uplo, const int *n, const float *alpha, const float *ap, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sspr(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *ap); void sspr2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *ap); void ssymv(const char *uplo, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void ssyr(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *a, const int *lda); void ssyr2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void stbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void stbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void stpmv(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void stpsv(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void strmv(const char *uplo, const char *transa, const char *diag, const int *n, const float *a, const int *lda, float *b, const int *incx); void strsv(const char *uplo, const char *trans, const char *diag, const int *n, const float *a, const int *lda, float *x, const int *incx); void sgem2vu(const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x1, const int *incx1, const float *x2, const int *incx2, const float *beta, float *y1, const int *incy1, float *y2, const int *incy2); void cgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void cgemv(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void cgerc(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void cgeru(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void chbmv(const char *uplo, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void chemv(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void cher(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *a, const int *lda); void cher2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void chpmv(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *ap, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void chpr(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *ap); void chpr2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *ap); void ctbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void ctbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void ctpmv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void ctpsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void ctrmv(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *incx); void ctrsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void cgem2vc(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x1, const int *incx1, const MKL_Complex8 *x2, const int *incx2, const MKL_Complex8 *beta, MKL_Complex8 *y1, const int *incy1, MKL_Complex8 *y2, const int *incy2); void scgemv(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void dgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dgemv(const char *trans, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dger(const int *m, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void dsbmv(const char *uplo, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dspmv(const char *uplo, const int *n, const double *alpha, const double *ap, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dspr(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *ap); void dspr2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *ap); void dsymv(const char *uplo, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dsyr(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *a, const int *lda); void dsyr2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void dtbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void dtbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void dtpmv(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void dtpsv(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void dtrmv(const char *uplo, const char *transa, const char *diag, const int *n, const double *a, const int *lda, double *b, const int *incx); void dtrsv(const char *uplo, const char *trans, const char *diag, const int *n, const double *a, const int *lda, double *x, const int *incx); void dgem2vu(const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x1, const int *incx1, const double *x2, const int *incx2, const double *beta, double *y1, const int *incy1, double *y2, const int *incy2); void zgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zgemv(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zgerc(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void zgeru(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void zhbmv(const char *uplo, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zhemv(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zher(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *a, const int *lda); void zher2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void zhpmv(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *ap, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zhpr(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *ap); void zhpr2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *ap); void ztbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ztbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ztpmv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ztpsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ztrmv(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *incx); void ztrsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void zgem2vc(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x1, const int *incx1, const MKL_Complex16 *x2, const int *incx2, const MKL_Complex16 *beta, MKL_Complex16 *y1, const int *incy1, MKL_Complex16 *y2, const int *incy2); void dzgemv(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void sgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); float* sgemm_alloc(const char *identifier, const int *m, const int *n, const int *k); void sgemm_pack(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const float *alpha, const float *src, const int *ld, float *dest); void sgemm_compute(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void sgemm_free(float *mat); void sgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const float *alpha_array, const float **a_array, const int *lda_array, const float **b_array, const int *ldb_array, const float *beta_array, float **c_array, const int *ldc_array, const int *group_count, const int *group_size); void sgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void ssymm(const char *side, const char *uplo, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void ssyr2k(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void ssyrk(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *beta, float *c, const int *ldc); void strmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void strsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void strsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const float *alpha_array, const float **a_array, const int *lda_array, float **b_array, const int *ldb, const int *group_count, const int *group_size); void cgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void scgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cgemm3m(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cgemm3m_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void cgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void chemm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cher2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const float *beta, MKL_Complex8 *c, const int *ldc); void cherk(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const MKL_Complex8 *a, const int *lda, const float *beta, MKL_Complex8 *c, const int *ldc); void csymm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void csyr2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void csyrk(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void ctrmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void ctrsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void ctrsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, MKL_Complex8 **b_array, const int *ldb, const int *group_count, const int *group_size); void dgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); double* dgemm_alloc(const char *identifier, const int *m, const int *n, const int *k); void dgemm_pack(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const double *alpha, const double *src, const int *ld, double *dest); void dgemm_compute(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dgemm_free(double *mat); void dgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const double *alpha_array, const double **a_array, const int *lda_array, const double **b_array, const int *ldb_array, const double *beta_array, double **c_array, const int *ldc_array, const int *group_count, const int *group_size); void dgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dsymm(const char *side, const char *uplo, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dsyr2k(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dsyrk(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *beta, double *c, const int *ldc); void dtrmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void dtrsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void dtrsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const double *alpha_array, const double **a_array, const int *lda_array, double **b_array, const int *ldb, const int *group_count, const int *group_size); void zgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void dzgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zgemm3m(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zgemm3m_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void zgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zhemm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zher2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const double *beta, MKL_Complex16 *c, const int *ldc); void zherk(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const MKL_Complex16 *a, const int *lda, const double *beta, MKL_Complex16 *c, const int *ldc); void zsymm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zsyr2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zsyrk(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ztrmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ztrsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ztrsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, MKL_Complex16 **b_array, const int *ldb, const int *group_count, const int *group_size); void gemm_s8u8s32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const char *a, const int *lda, const char *ao, const unsigned char *b, const int *ldb, const char *bo, const float *beta, int *c, const int *ldc, const int *co); void gemm_s16s16s32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const short *a, const int *lda, const short *ao, const short *b, const int *ldb, const short *bo, const float *beta, int *c, const int *ldc, const int *co); #line 40 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_trans.h" void MKL_Simatcopy( const char ordering, const char trans, size_t rows, size_t cols, const float alpha, float * AB, size_t lda, size_t ldb); void MKL_Dimatcopy( const char ordering, const char trans, size_t rows, size_t cols, const double alpha, double * AB, size_t lda, size_t ldb); void MKL_Cimatcopy( const char ordering, const char trans, size_t rows, size_t cols, const MKL_Complex8 alpha, MKL_Complex8 * AB, size_t lda, size_t ldb); void MKL_Zimatcopy( const char ordering, const char trans, size_t rows, size_t cols, const MKL_Complex16 alpha, MKL_Complex16 * AB, size_t lda, size_t ldb); void MKL_Somatcopy( char ordering, char trans, size_t rows, size_t cols, const float alpha, const float * A, size_t lda, float * B, size_t ldb); void MKL_Domatcopy( char ordering, char trans, size_t rows, size_t cols, const double alpha, const double * A, size_t lda, double * B, size_t ldb); void MKL_Comatcopy( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex8 alpha, const MKL_Complex8 * A, size_t lda, MKL_Complex8 * B, size_t ldb); void MKL_Zomatcopy( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex16 alpha, const MKL_Complex16 * A, size_t lda, MKL_Complex16 * B, size_t ldb); void MKL_Somatcopy2( char ordering, char trans, size_t rows, size_t cols, const float alpha, const float * A, size_t lda, size_t stridea, float * B, size_t ldb, size_t strideb); void MKL_Domatcopy2( char ordering, char trans, size_t rows, size_t cols, const double alpha, const double * A, size_t lda, size_t stridea, double * B, size_t ldb, size_t strideb); void MKL_Comatcopy2( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex8 alpha, const MKL_Complex8 * A, size_t lda, size_t stridea, MKL_Complex8 * B, size_t ldb, size_t strideb); void MKL_Zomatcopy2( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex16 alpha, const MKL_Complex16 * A, size_t lda, size_t stridea, MKL_Complex16 * B, size_t ldb, size_t strideb); void MKL_Somatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const float alpha, const float * A, size_t lda, const float beta, const float * B, size_t ldb, float * C, size_t ldc); void MKL_Domatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const double alpha, const double * A, size_t lda, const double beta, const double * B, size_t ldb, double * C, size_t ldc); void MKL_Comatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const MKL_Complex8 alpha, const MKL_Complex8 * A, size_t lda, const MKL_Complex8 beta, const MKL_Complex8 * B, size_t ldb, MKL_Complex8 * C, size_t ldc); void MKL_Zomatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const MKL_Complex16 alpha, const MKL_Complex16 * A, size_t lda, const MKL_Complex16 beta, const MKL_Complex16 * B, size_t ldb, MKL_Complex16 * C, size_t ldc); #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_cblas.h" #line 37 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_cblas.h" typedef enum {CblasRowMajor=101, CblasColMajor=102} CBLAS_LAYOUT; typedef enum {CblasNoTrans=111, CblasTrans=112, CblasConjTrans=113} CBLAS_TRANSPOSE; typedef enum {CblasUpper=121, CblasLower=122} CBLAS_UPLO; typedef enum {CblasNonUnit=131, CblasUnit=132} CBLAS_DIAG; typedef enum {CblasLeft=141, CblasRight=142} CBLAS_SIDE; typedef enum {CblasPacked=151} CBLAS_STORAGE; typedef enum {CblasAMatrix=161, CblasBMatrix=162} CBLAS_IDENTIFIER; typedef enum {CblasRowOffset=171, CblasColOffset=172, CblasFixOffset=173} CBLAS_OFFSET; typedef CBLAS_LAYOUT CBLAS_ORDER; double cblas_dcabs1(const void *z); float cblas_scabs1(const void *c); float cblas_sdot(const int N, const float *X, const int incX, const float *Y, const int incY); float cblas_sdoti(const int N, const float *X, const int *indx, const float *Y); double cblas_ddot(const int N, const double *X, const int incX, const double *Y, const int incY); double cblas_ddoti(const int N, const double *X, const int *indx, const double *Y); double cblas_dsdot(const int N, const float *X, const int incX, const float *Y, const int incY); float cblas_sdsdot(const int N, const float sb, const float *X, const int incX, const float *Y, const int incY); void cblas_cdotu_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotu); void cblas_cdotui_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); void cblas_cdotc_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotc); void cblas_cdotci_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); void cblas_zdotu_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotu); void cblas_zdotui_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); void cblas_zdotc_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotc); void cblas_zdotci_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); float cblas_snrm2(const int N, const float *X, const int incX); float cblas_sasum(const int N, const float *X, const int incX); double cblas_dnrm2(const int N, const double *X, const int incX); double cblas_dasum(const int N, const double *X, const int incX); float cblas_scnrm2(const int N, const void *X, const int incX); float cblas_scasum(const int N, const void *X, const int incX); double cblas_dznrm2(const int N, const void *X, const int incX); double cblas_dzasum(const int N, const void *X, const int incX); size_t cblas_isamax(const int N, const float *X, const int incX); size_t cblas_idamax(const int N, const double *X, const int incX); size_t cblas_icamax(const int N, const void *X, const int incX); size_t cblas_izamax(const int N, const void *X, const int incX); size_t cblas_isamin(const int N, const float *X, const int incX); size_t cblas_idamin(const int N, const double *X, const int incX); size_t cblas_icamin(const int N, const void *X, const int incX); size_t cblas_izamin(const int N, const void *X, const int incX); void cblas_sswap(const int N, float *X, const int incX, float *Y, const int incY); void cblas_scopy(const int N, const float *X, const int incX, float *Y, const int incY); void cblas_saxpy(const int N, const float alpha, const float *X, const int incX, float *Y, const int incY); void cblas_saxpby(const int N, const float alpha, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_saxpyi(const int N, const float alpha, const float *X, const int *indx, float *Y); void cblas_sgthr(const int N, const float *Y, float *X, const int *indx); void cblas_sgthrz(const int N, float *Y, float *X, const int *indx); void cblas_ssctr(const int N, const float *X, const int *indx, float *Y); void cblas_srotg(float *a, float *b, float *c, float *s); void cblas_dswap(const int N, double *X, const int incX, double *Y, const int incY); void cblas_dcopy(const int N, const double *X, const int incX, double *Y, const int incY); void cblas_daxpy(const int N, const double alpha, const double *X, const int incX, double *Y, const int incY); void cblas_daxpby(const int N, const double alpha, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_daxpyi(const int N, const double alpha, const double *X, const int *indx, double *Y); void cblas_dgthr(const int N, const double *Y, double *X, const int *indx); void cblas_dgthrz(const int N, double *Y, double *X, const int *indx); void cblas_dsctr(const int N, const double *X, const int *indx, double *Y); void cblas_drotg(double *a, double *b, double *c, double *s); void cblas_cswap(const int N, void *X, const int incX, void *Y, const int incY); void cblas_ccopy(const int N, const void *X, const int incX, void *Y, const int incY); void cblas_caxpy(const int N, const void *alpha, const void *X, const int incX, void *Y, const int incY); void cblas_caxpby(const int N, const void *alpha, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_caxpyi(const int N, const void *alpha, const void *X, const int *indx, void *Y); void cblas_cgthr(const int N, const void *Y, void *X, const int *indx); void cblas_cgthrz(const int N, void *Y, void *X, const int *indx); void cblas_csctr(const int N, const void *X, const int *indx, void *Y); void cblas_crotg(void *a, const void *b, float *c, void *s); void cblas_zswap(const int N, void *X, const int incX, void *Y, const int incY); void cblas_zcopy(const int N, const void *X, const int incX, void *Y, const int incY); void cblas_zaxpy(const int N, const void *alpha, const void *X, const int incX, void *Y, const int incY); void cblas_zaxpby(const int N, const void *alpha, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zaxpyi(const int N, const void *alpha, const void *X, const int *indx, void *Y); void cblas_zgthr(const int N, const void *Y, void *X, const int *indx); void cblas_zgthrz(const int N, void *Y, void *X, const int *indx); void cblas_zsctr(const int N, const void *X, const int *indx, void *Y); void cblas_zrotg(void *a, const void *b, double *c, void *s); void cblas_srotmg(float *d1, float *d2, float *b1, const float b2, float *P); void cblas_srot(const int N, float *X, const int incX, float *Y, const int incY, const float c, const float s); void cblas_sroti(const int N, float *X, const int *indx, float *Y, const float c, const float s); void cblas_srotm(const int N, float *X, const int incX, float *Y, const int incY, const float *P); void cblas_drotmg(double *d1, double *d2, double *b1, const double b2, double *P); void cblas_drot(const int N, double *X, const int incX, double *Y, const int incY, const double c, const double s); void cblas_drotm(const int N, double *X, const int incX, double *Y, const int incY, const double *P); void cblas_droti(const int N, double *X, const int *indx, double *Y, const double c, const double s); void cblas_csrot(const int N, void *X, const int incX, void *Y, const int incY, const float c, const float s); void cblas_zdrot(const int N, void *X, const int incX, void *Y, const int incY, const double c, const double s); void cblas_sscal(const int N, const float alpha, float *X, const int incX); void cblas_dscal(const int N, const double alpha, double *X, const int incX); void cblas_cscal(const int N, const void *alpha, void *X, const int incX); void cblas_zscal(const int N, const void *alpha, void *X, const int incX); void cblas_csscal(const int N, const float alpha, void *X, const int incX); void cblas_zdscal(const int N, const double alpha, void *X, const int incX); void cblas_sgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_sgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_strmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *A, const int lda, float *X, const int incX); void cblas_stbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const float *A, const int lda, float *X, const int incX); void cblas_stpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *Ap, float *X, const int incX); void cblas_strsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *A, const int lda, float *X, const int incX); void cblas_stbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const float *A, const int lda, float *X, const int incX); void cblas_stpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *Ap, float *X, const int incX); void cblas_dgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dtrmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *A, const int lda, double *X, const int incX); void cblas_dtbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const double *A, const int lda, double *X, const int incX); void cblas_dtpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *Ap, double *X, const int incX); void cblas_dtrsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *A, const int lda, double *X, const int incX); void cblas_dtbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const double *A, const int lda, double *X, const int incX); void cblas_dtpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *Ap, double *X, const int incX); void cblas_cgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_cgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_ctrmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ctbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ctpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_ctrsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ctbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ctpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_zgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_ztrmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ztbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ztpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_ztrsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ztbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ztpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_ssymv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_ssbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_sspmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *Ap, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_sger(const CBLAS_LAYOUT Layout, const int M, const int N, const float alpha, const float *X, const int incX, const float *Y, const int incY, float *A, const int lda); void cblas_ssyr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, float *A, const int lda); void cblas_sspr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, float *Ap); void cblas_ssyr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, const float *Y, const int incY, float *A, const int lda); void cblas_sspr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, const float *Y, const int incY, float *A); void cblas_dsymv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dsbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dspmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *Ap, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dger(const CBLAS_LAYOUT Layout, const int M, const int N, const double alpha, const double *X, const int incX, const double *Y, const int incY, double *A, const int lda); void cblas_dsyr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, double *A, const int lda); void cblas_dspr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, double *Ap); void cblas_dsyr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, const double *Y, const int incY, double *A, const int lda); void cblas_dspr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, const double *Y, const int incY, double *A); void cblas_chemv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_chbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_chpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *Ap, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_cgeru(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_cgerc(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_cher(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const void *X, const int incX, void *A, const int lda); void cblas_chpr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const void *X, const int incX, void *A); void cblas_cher2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_chpr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *Ap); void cblas_zhemv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zhbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zhpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *Ap, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zgeru(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_zgerc(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_zher(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const void *X, const int incX, void *A, const int lda); void cblas_zhpr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const void *X, const int incX, void *A); void cblas_zher2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_zhpr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *Ap); void cblas_sgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_sgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const float *alpha_Array, const float **A_Array, const int *lda_Array, const float **B_Array, const int *ldb_Array, const float *beta_Array, float **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_sgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_ssymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_ssyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const float alpha, const float *A, const int lda, const float beta, float *C, const int ldc); void cblas_ssyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_strmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const float alpha, const float *A, const int lda, float *B, const int ldb); void cblas_strsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const float alpha, const float *A, const int lda, float *B, const int ldb); void cblas_strsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const float *alpha_Array, const float **A_Array, const int *lda_Array, float **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_dgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const double *alpha_Array, const double **A_Array, const int *lda_Array, const double **B_Array, const int* ldb_Array, const double *beta_Array, double **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_dgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dsymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dsyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const double alpha, const double *A, const int lda, const double beta, double *C, const int ldc); void cblas_dsyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dtrmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const double alpha, const double *A, const int lda, double *B, const int ldb); void cblas_dtrsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const double alpha, const double *A, const int lda, double *B, const int ldb); void cblas_dtrsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *Transa_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const double *alpha_Array, const double **A_Array, const int *lda_Array, double **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_cgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_cgemm3m(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_cgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_cgemm3m_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_cgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_csymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_csyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *beta, void *C, const int ldc); void cblas_csyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_ctrmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ctrsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ctrsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *Transa_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, void **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_zgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zgemm3m(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_zgemm3m_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_zgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zsymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zsyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *beta, void *C, const int ldc); void cblas_zsyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_ztrmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ztrsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ztrsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *Transa_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, void **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_chemm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_cherk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const float alpha, const void *A, const int lda, const float beta, void *C, const int ldc); void cblas_cher2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const float beta, void *C, const int ldc); void cblas_zhemm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zherk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const double alpha, const void *A, const int lda, const double beta, void *C, const int ldc); void cblas_zher2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const double beta, void *C, const int ldc); __declspec(dllexport) float* cblas_sgemm_alloc(const CBLAS_IDENTIFIER identifier, const int M, const int N, const int K); void cblas_sgemm_pack(const CBLAS_LAYOUT Layout, const CBLAS_IDENTIFIER identifier, const CBLAS_TRANSPOSE Trans, const int M, const int N, const int K, const float alpha, const float *src, const int ld, float *dest); void cblas_sgemm_compute(const CBLAS_LAYOUT Layout, const int TransA, const int TransB, const int M, const int N, const int K, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_sgemm_free(float *dest); __declspec(dllexport) double* cblas_dgemm_alloc(const CBLAS_IDENTIFIER identifier, const int M, const int N, const int K); void cblas_dgemm_pack(const CBLAS_LAYOUT Layout, const CBLAS_IDENTIFIER identifier, const CBLAS_TRANSPOSE Trans, const int M, const int N, const int K, const double alpha, const double *src, const int ld, double *dest); void cblas_dgemm_compute(const CBLAS_LAYOUT Layout, const int TransA, const int TransB, const int M, const int N, const int K, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dgemm_free(double *dest); void cblas_gemm_s16s16s32(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const CBLAS_OFFSET OffsetC, const int M, const int N, const int K, const float alpha, const short *A, const int lda, const short ao, const short *B, const int ldb, const short bo, const float beta, int *C, const int ldc, const int *cb); void cblas_gemm_s8u8s32(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const CBLAS_OFFSET OffsetC, const int M, const int N, const int K, const float alpha, const void *A, const int lda, const char ao, const void *B, const int ldb, const char bo, const float beta, int *C, const int ldc, const int *cb); #line 42 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" #line 35 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" __declspec(deprecated) void mkl_scsrmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scsrsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scscmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scscsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scoomv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scoosv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_sdiamv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sdiasv (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiagemv(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiasymv(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sskymv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sskysv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void mkl_sbsrmv (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sbsrsv(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scsrsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scscmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scscsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scoomm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scoosm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiamm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiasm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskysm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskymm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrsm(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSRSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSCMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSCSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCOOMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCOOSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SDIAMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SDIASV (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIAGEMV(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIASYMV(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SSKYMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SSKYSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void MKL_SBSRMV (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SBSRSV(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIAMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIASM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYSM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRSM(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_dcsrmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcsrsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcscmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcscsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcoomv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcoosv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_ddiamv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_ddiasv (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiagemv(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiasymv(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_dskymv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dskysv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void mkl_dbsrmv (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dbsrsv(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcsrsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoomm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoosm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiamm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiasm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskysm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskymm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrsm(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSRSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSCMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSCSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCOOMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCOOSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DDIAMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DDIASV (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIAGEMV(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIASYMV(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DSKYMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DSKYSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void MKL_DBSRMV (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DBSRSV(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIAMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIASM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYSM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRSM(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ccsrmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoomv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiamv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasv (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiagemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskymv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskysv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccsrsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoosm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiasm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskysm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASV (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIASM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoomv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiamv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasv (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiagemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskymv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskysv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoosm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiasm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskysm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASV (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIASM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_dcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_dcsrcoo(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_ddnscsr(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_dcsrcsc(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_dcsrdia(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_dcsrsky(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_scsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_scsrcoo(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_sdnscsr(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_scsrcsc(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_scsrdia(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_scsrsky(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_ccsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_ccsrcoo(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_cdnscsr(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_ccsrcsc(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_ccsrdia(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_ccsrsky(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_zcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_zcsrcoo(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_zdnscsr(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_zcsrcsc(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_zcsrdia(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_zcsrsky(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_DCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_DCSRCOO(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_DDNSCSR(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_DCSRCSC(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_DCSRDIA(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_DCSRSKY(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_SCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_SCSRCOO(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_SDNSCSR(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_SCSRCSC(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_SCSRDIA(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_SCSRSKY(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_CCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_CCSRCOO(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_CDNSCSR(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_CCSRCSC(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_CCSRDIA(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_CCSRSKY(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_ZCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_ZCSRCOO(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_ZDNSCSR(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_ZCSRCSC(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_ZCSRDIA(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_ZCSRSKY(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_dcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_dcsrmultd(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void mkl_dcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultd(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void mkl_scsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void mkl_ccsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void mkl_zcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTD(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void MKL_DCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTD(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void MKL_SCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void MKL_CCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void MKL_ZCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); typedef enum { SPARSE_STATUS_SUCCESS = 0, SPARSE_STATUS_NOT_INITIALIZED = 1, SPARSE_STATUS_ALLOC_FAILED = 2, SPARSE_STATUS_INVALID_VALUE = 3, SPARSE_STATUS_EXECUTION_FAILED = 4, SPARSE_STATUS_INTERNAL_ERROR = 5, SPARSE_STATUS_NOT_SUPPORTED = 6 } sparse_status_t; typedef enum { SPARSE_OPERATION_NON_TRANSPOSE = 10, SPARSE_OPERATION_TRANSPOSE = 11, SPARSE_OPERATION_CONJUGATE_TRANSPOSE = 12 } sparse_operation_t; typedef enum { SPARSE_MATRIX_TYPE_GENERAL = 20, SPARSE_MATRIX_TYPE_SYMMETRIC = 21, SPARSE_MATRIX_TYPE_HERMITIAN = 22, SPARSE_MATRIX_TYPE_TRIANGULAR = 23, SPARSE_MATRIX_TYPE_DIAGONAL = 24, SPARSE_MATRIX_TYPE_BLOCK_TRIANGULAR = 25, SPARSE_MATRIX_TYPE_BLOCK_DIAGONAL = 26 } sparse_matrix_type_t; typedef enum { SPARSE_INDEX_BASE_ZERO = 0, SPARSE_INDEX_BASE_ONE = 1 } sparse_index_base_t; typedef enum { SPARSE_FILL_MODE_LOWER = 40, SPARSE_FILL_MODE_UPPER = 41, SPARSE_FILL_MODE_FULL = 42 } sparse_fill_mode_t; typedef enum { SPARSE_DIAG_NON_UNIT = 50, SPARSE_DIAG_UNIT = 51 } sparse_diag_type_t; typedef enum { SPARSE_LAYOUT_ROW_MAJOR = 101, SPARSE_LAYOUT_COLUMN_MAJOR = 102 } sparse_layout_t; typedef enum { SPARSE_VERBOSE_OFF = 70, SPARSE_VERBOSE_BASIC = 71, SPARSE_VERBOSE_EXTENDED = 72 } verbose_mode_t; typedef enum { SPARSE_MEMORY_NONE = 80, SPARSE_MEMORY_AGGRESSIVE = 81 } sparse_memory_usage_t; typedef enum { SPARSE_STAGE_FULL_MULT = 90, SPARSE_STAGE_NNZ_COUNT = 91, SPARSE_STAGE_FINALIZE_MULT = 92, SPARSE_STAGE_FULL_MULT_NO_VAL = 93, SPARSE_STAGE_FINALIZE_MULT_NO_VAL = 94 } sparse_request_t; struct sparse_matrix; typedef struct sparse_matrix *sparse_matrix_t; struct matrix_descr { sparse_matrix_type_t type; sparse_fill_mode_t mode; sparse_diag_type_t diag; }; sparse_status_t mkl_sparse_s_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_copy( const sparse_matrix_t source, struct matrix_descr descr, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_destroy( sparse_matrix_t A ); sparse_status_t mkl_sparse_get_error_info( sparse_matrix_t A, int *info ); sparse_status_t mkl_sparse_convert_csr ( const sparse_matrix_t source, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_convert_bsr ( const sparse_matrix_t source, int block_size, sparse_layout_t block_layout, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_s_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_set_value( sparse_matrix_t A, int row, int col, float value ); sparse_status_t mkl_sparse_d_set_value( sparse_matrix_t A, int row, int col, double value ); sparse_status_t mkl_sparse_c_set_value( sparse_matrix_t A, int row, int col, MKL_Complex8 value ); sparse_status_t mkl_sparse_z_set_value( sparse_matrix_t A, int row, int col, MKL_Complex16 value ); sparse_status_t mkl_sparse_set_verbose_mode ( verbose_mode_t verbose ); sparse_status_t mkl_sparse_set_mv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_mm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_sv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_sm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_memory_hint ( sparse_matrix_t A, sparse_memory_usage_t policy ); sparse_status_t mkl_sparse_optimize ( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_mv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y ); sparse_status_t mkl_sparse_d_mv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y ); sparse_status_t mkl_sparse_c_mv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_mv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_trsv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float *y ); sparse_status_t mkl_sparse_d_trsv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double *y ); sparse_status_t mkl_sparse_c_trsv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_trsv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_mm( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float beta, float *y, int ldy ); sparse_status_t mkl_sparse_d_mm( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double beta, double *y, int ldy ); sparse_status_t mkl_sparse_c_mm( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 beta, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_mm( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 beta, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_trsm ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float *y, int ldy ); sparse_status_t mkl_sparse_d_trsm ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double *y, int ldy ); sparse_status_t mkl_sparse_c_trsm ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_trsm ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_add( sparse_operation_t operation, const sparse_matrix_t A, float alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_d_add( sparse_operation_t operation, const sparse_matrix_t A, double alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_c_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_z_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_spmm( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sp2m ( sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, sparse_request_t request, sparse_matrix_t *C ); sparse_status_t mkl_sparse_syrk ( sparse_operation_t operation, const sparse_matrix_t A, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sypr ( sparse_operation_t transA, const sparse_matrix_t A, const sparse_matrix_t B, struct matrix_descr descrB, sparse_matrix_t *C, sparse_request_t request ); sparse_status_t mkl_sparse_s_syprd ( const sparse_operation_t op, const sparse_matrix_t A, float *B, const sparse_layout_t layoutB, const int ldb, float alpha, float beta, float *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_d_syprd ( const sparse_operation_t op, const sparse_matrix_t A, double *B, const sparse_layout_t layoutB, const int ldb, double alpha, double beta, double *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_c_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex8 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_z_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex16 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_order( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, float *C, int ldc ); sparse_status_t mkl_sparse_d_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, double *C, int ldc ); sparse_status_t mkl_sparse_c_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex8 *C, int ldc ); sparse_status_t mkl_sparse_z_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex16 *C, int ldc ); sparse_status_t mkl_sparse_d_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const double alpha, const double beta, double *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_s_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const float alpha, const float beta, float *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_z_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex16 alpha, const MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_c_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex8 alpha, const MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_set_symgs_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_d_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x, double *y); sparse_status_t mkl_sparse_d_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x); sparse_status_t mkl_sparse_set_dotmv_hint( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expectedCalls ); sparse_status_t mkl_sparse_d_dotmv( sparse_operation_t transA, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y, double *d ); sparse_status_t mkl_sparse_s_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x, float *y); sparse_status_t mkl_sparse_s_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x); sparse_status_t mkl_sparse_s_dotmv( sparse_operation_t transA, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y, float *d ); sparse_status_t mkl_sparse_c_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x, MKL_Complex8 *y); sparse_status_t mkl_sparse_c_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x); sparse_status_t mkl_sparse_c_dotmv( sparse_operation_t transA, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y, MKL_Complex8 *d ); sparse_status_t mkl_sparse_z_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x, MKL_Complex16 *y); sparse_status_t mkl_sparse_z_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x); sparse_status_t mkl_sparse_z_dotmv( sparse_operation_t transA, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y, MKL_Complex16 *d ); sparse_status_t mkl_sparse_s_syrkd( sparse_operation_t operation, const sparse_matrix_t A, float alpha, float beta, float *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_d_syrkd( sparse_operation_t operation, const sparse_matrix_t A, double alpha, double beta, double *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_c_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_z_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, sparse_layout_t layout, int ldc ); #line 43 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_lapack.h" typedef int (*MKL_C_SELECT_FUNCTION_1) ( const MKL_Complex8* ); typedef int (*MKL_C_SELECT_FUNCTION_2) ( const MKL_Complex8*, const MKL_Complex8* ); typedef int (*MKL_D_SELECT_FUNCTION_2) ( const double*, const double* ); typedef int (*MKL_D_SELECT_FUNCTION_3) ( const double*, const double*, const double* ); typedef int (*MKL_S_SELECT_FUNCTION_2) ( const float*, const float* ); typedef int (*MKL_S_SELECT_FUNCTION_3) ( const float*, const float*, const float* ); typedef int (*MKL_Z_SELECT_FUNCTION_1) ( const MKL_Complex16* ); typedef int (*MKL_Z_SELECT_FUNCTION_2) ( const MKL_Complex16*, const MKL_Complex16* ); void CGELQ( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGELQ_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgelq( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgelq_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGELQT( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CGELQT_( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgelqt( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgelqt_( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CGELQT3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGELQT3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgelqt3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgelqt3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CGEQR( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGEQR_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgeqr( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgeqr_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgetsls( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLASWLQ( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void claswlq( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void claswlq_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CLATSQR( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CLATSQR_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void clatsqr( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void clatsqr_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CTPLQT( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CTPLQT_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctplqt( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctplqt_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CTPLQT2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void CTPLQT2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctplqt2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctplqt2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void CTPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CTPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void DGELQ( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DGELQ_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgelq( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgelq_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DGELQT( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void DGELQT_( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgelqt( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgelqt_( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void DGELQT3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGELQT3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgelqt3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgelqt3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void DGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void DGEQR( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DGEQR_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgeqr( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgeqr_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLASWLQ( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlaswlq( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlaswlq_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DLATSQR( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DLATSQR_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlatsqr( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlatsqr_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DTPLQT( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void DTPLQT_( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtplqt( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtplqt_( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void DTPLQT2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void DTPLQT2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtplqt2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtplqt2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void DTPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void DTPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void SGELQ( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void SGELQ_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgelq( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgelq_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void DGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgetsls( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void SGELQT( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void SGELQT_( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgelqt( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgelqt_( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void SGELQT3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGELQT3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgelqt3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgelqt3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void SGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void SGEQR( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void SGEQR_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgeqr( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgeqr_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void SGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgetsls( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLASWLQ( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void SLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slaswlq( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slaswlq_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void STPLQT( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void STPLQT_( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stplqt( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stplqt_( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void STPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void STPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void ZGELQ( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void ZGELQ_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgelq( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgelq_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void SGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLATSQR( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void SLATSQR_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slatsqr( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slatsqr_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void STPLQT2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void STPLQT2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stplqt2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stplqt2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void ZGELQT( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZGELQT_( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgelqt( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgelqt_( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZGELQT3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGELQT3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgelqt3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgelqt3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZGEQR( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQR_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgeqr( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgeqr_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void ZGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgetsls( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLASWLQ( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlaswlq( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlaswlq_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZLATSQR( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZLATSQR_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlatsqr( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlatsqr_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZTPLQT( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZTPLQT_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztplqt( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztplqt_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZTPLQT2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ZTPLQT2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztplqt2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztplqt2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ZTPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZTPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void CHESV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_AA( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_AA_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_aa( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_aa_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void CHETRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void chetrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void chetrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void CLAHEF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void CLAHEF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clahef_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clahef_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void DLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void DLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void dlasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void dlasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void DSYSV_AA( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_AA_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_aa( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_aa_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYTRF_AA( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_AA_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_aa( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_aa_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void DSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void dsytrs_aa( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void dsytrs_aa_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void SLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void SLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void slasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void slasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void SSYSV_AA( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_AA_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_aa( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_aa_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYTRF_AA( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_AA_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_aa( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_aa_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void SSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void ssytrs_aa( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void ssytrs_aa_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void ZHESV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_AA( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_AA_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_aa( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_aa_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void ZHETRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zhetrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zhetrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void ZLAHEF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void ZLAHEF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlahef_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlahef_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void CGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void DGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void SGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void ZGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void CHECON_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHECON_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHESV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHETF2_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CHETF2_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void chetf2_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void chetf2_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CHETRF_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_3X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CHETRI_3X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri_3x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri_3x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CHETRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHETRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CLAHEF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHEF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLARFY( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARFY_( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfy( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfy_( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void CLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void CLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CSYCON_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCON_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCONVF( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYCONVF_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csyconvf( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csyconvf_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYCONVF_ROOK( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void CSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void csyconvf_rook( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void csyconvf_rook_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void CSYSV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYTF2_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYTF2_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csytf2_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csytf2_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYTRF_AA( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_AA_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_aa( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_aa_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_3X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CSYTRI_3X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void csytri_3x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void csytri_3x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CSYTRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void CSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void csytrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void csytrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void DLARFY( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARFY_( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarfy( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarfy_( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void DLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void DSYCON_3( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCON_3_( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_3( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_3_( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCONVF( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYCONVF_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsyconvf( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsyconvf_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYCONVF_ROOK( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void DSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void dsyconvf_rook( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void dsyconvf_rook_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void DSYSV_RK( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_RK_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rk( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rk_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYTF2_RK( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYTF2_RK_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsytf2_rk( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsytf2_rk_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYTRF_RK( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_RK_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rk( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rk_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_3( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_3_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri_3( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri_3_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_3X( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void DSYTRI_3X_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void dsytri_3x( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void dsytri_3x_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void DSYTRS_3( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void DSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_3( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_3_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void SLARFY( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARFY_( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarfy( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarfy_( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void SLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void SSYCON_3( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCON_3_( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_3( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_3_( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCONVF( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYCONVF_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssyconvf( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssyconvf_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYCONVF_ROOK( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void SSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void ssyconvf_rook( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void ssyconvf_rook_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void SSYSV_RK( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_RK_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rk( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rk_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYTF2_RK( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYTF2_RK_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssytf2_rk( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssytf2_rk_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYTRF_RK( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_RK_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rk( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rk_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_3( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_3_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri_3( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri_3_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_3X( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void SSYTRI_3X_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void ssytri_3x( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void ssytri_3x_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void SSYTRS_3( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void SSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_3( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_3_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void ZHECON_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHECON_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHESV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHETF2_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZHETF2_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zhetf2_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zhetf2_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZHETRF_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_3X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZHETRI_3X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri_3x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri_3x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZHETRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHETRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZLAHEF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHEF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLARFY( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARFY_( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfy( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfy_( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void ZLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void ZLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZSYCON_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCON_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCONVF( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYCONVF_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsyconvf( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsyconvf_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYCONVF_ROOK( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void ZSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void zsyconvf_rook( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void zsyconvf_rook_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void ZSYSV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTF2_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYTF2_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsytf2_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsytf2_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYTRF_AA( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_AA_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_aa( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_aa_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_3X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZSYTRI_3X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zsytri_3x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zsytri_3x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZSYTRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zsytrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zsytrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void CHB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void CHB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void chb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void chb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void CHBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEEV_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEV_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEVD_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHETRD_2STAGE( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_2STAGE_( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_2stage( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_2stage_( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_hb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_hb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HE2HB( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HE2HB_( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_he2hb( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_he2hb_( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void DSB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void DSB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void dsb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void dsb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void DSBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DSBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DSBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYEV_2STAGE( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEV_2STAGE_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev_2stage( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev_2stage_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEVD_2STAGE( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd_2stage( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd_2stage_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYTRD_2STAGE( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void DSYTRD_2STAGE_( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void dsytrd_2stage( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void dsytrd_2stage_( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void DSYTRD_SB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void DSYTRD_SB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void dsytrd_sb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void dsytrd_sb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void DSYTRD_SY2SB( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); void DSYTRD_SY2SB_( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); void dsytrd_sy2sb( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); void dsytrd_sy2sb_( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); int IPARAM2STAGE( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); int IPARAM2STAGE_( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); int iparam2stage( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); int iparam2stage_( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); void SSB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void SSB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void ssb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void ssb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void SSBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SSBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SSBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYEV_2STAGE( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEV_2STAGE_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev_2stage( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev_2stage_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEVD_2STAGE( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd_2stage( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd_2stage_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYTRD_2STAGE( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void SSYTRD_2STAGE_( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void ssytrd_2stage( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void ssytrd_2stage_( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void SSYTRD_SB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void SSYTRD_SB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void ssytrd_sb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void ssytrd_sb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void SSYTRD_SY2SB( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void SSYTRD_SY2SB_( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void ssytrd_sy2sb( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void ssytrd_sy2sb_( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void ZHB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void ZHB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void zhb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void zhb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void ZHBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEEV_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEV_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEVD_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHETRD_2STAGE( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_2STAGE_( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_2stage( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_2stage_( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_hb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_hb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HE2HB( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HE2HB_( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_he2hb( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_he2hb_( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void MKL_CGETRFNP( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void MKL_CGETRFNP_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnp( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnp_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void MKL_DGETRFNP( const int* m, const int* n, double* a, const int* lda, int* info ); void MKL_DGETRFNP_( const int* m, const int* n, double* a, const int* lda, int* info ); void mkl_dgetrfnp( const int* m, const int* n, double* a, const int* lda, int* info ); void mkl_dgetrfnp_( const int* m, const int* n, double* a, const int* lda, int* info ); void MKL_SGETRFNP( const int* m, const int* n, float* a, const int* lda, int* info ); void MKL_SGETRFNP_( const int* m, const int* n, float* a, const int* lda, int* info ); void mkl_sgetrfnp( const int* m, const int* n, float* a, const int* lda, int* info ); void mkl_sgetrfnp_( const int* m, const int* n, float* a, const int* lda, int* info ); void MKL_ZGETRFNP( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void MKL_ZGETRFNP_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnp( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnp_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void MKL_CGETRINP( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void MKL_CGETRINP_( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void mkl_cgetrinp( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void mkl_cgetrinp_( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void MKL_DGETRINP( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void MKL_DGETRINP_( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void mkl_dgetrinp( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void mkl_dgetrinp_( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void MKL_SGETRINP( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void MKL_SGETRINP_( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void mkl_sgetrinp( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void mkl_sgetrinp_( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void MKL_ZGETRINP( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void MKL_ZGETRINP_( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void mkl_zgetrinp( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void mkl_zgetrinp_( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void CGEJSV( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void CGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void ZGEJSV( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void ZGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void DGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void DGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void SGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void SGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void CGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void CGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void cgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void cgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void ZGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void ZGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void zgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void zgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void CGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void CGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void cgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void cgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void ZGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void ZGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void zgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void zgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void DGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void DGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void dggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void dggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void SGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void SGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void sggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void sggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void CGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void ZGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void DGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void DGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void dggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void dggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void SGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void SGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void sggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void sggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void CGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void ZGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void CGSVJ0( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void CGSVJ0_( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj0( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj0_( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void ZGSVJ0( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void ZGSVJ0_( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj0( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj0_( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void CGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void CGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void ZGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void ZGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void CPOTRF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void DPOTRF2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRF2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void SPOTRF2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRF2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void ZPOTRF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void DBDSVDX( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void DBDSVDX_( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void dbdsvdx( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void dbdsvdx_( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void SBDSVDX( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void SBDSVDX_( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void sbdsvdx( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void sbdsvdx_( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void CGETRF2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETRF2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void DGETRF2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETRF2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void SGETRF2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETRF2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ZGETRF2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETRF2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void CGGEV3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGGEV3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void ZGGEV3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGGEV3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void DGGEV3( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGGEV3_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev3( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev3_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void SGGEV3( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGGEV3_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev3( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev3_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void CUNM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void ZUNM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void CGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void DGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void SGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void sgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void sgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ZGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void CGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void ZGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void DGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void DGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void SGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void SGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void DORM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dorm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dorm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void SORM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sorm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sorm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void CHECON_ROOK( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHECON_ROOK_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_rook( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_rook_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHESV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHETF2_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETF2_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETRF_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRI_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHETRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CLAHEF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHEF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CSYCON_ROOK( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCON_ROOK_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_rook( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_rook_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYTF2_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTF2_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTRF_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRI_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void DLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DSYCON_ROOK( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCON_ROOK_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_rook( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_rook_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rook( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rook_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYTF2_ROOK( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTF2_ROOK_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2_rook( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2_rook_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTRF_ROOK( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_ROOK_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rook( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rook_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_ROOK( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRI_ROOK_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri_rook( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri_rook_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_rook( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_rook_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void SLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SSYCON_ROOK( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCON_ROOK_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_rook( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_rook_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rook( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rook_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYTF2_ROOK( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTF2_ROOK_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2_rook( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2_rook_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTRF_ROOK( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_ROOK_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rook( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rook_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_ROOK( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRI_ROOK_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri_rook( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri_rook_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_rook( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_rook_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ZHECON_ROOK( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHECON_ROOK_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_rook( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_rook_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHESV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHETF2_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETF2_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETRF_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRI_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHETRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZLAHEF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHEF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZSYCON_ROOK( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCON_ROOK_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_rook( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_rook_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTF2_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTF2_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTRF_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRI_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void CUNBDB1( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB1_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb1( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb1_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB2( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB2_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb2( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb2_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB3( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB3_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb3( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb3_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB4( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB4_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb4( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb4_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB5( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB5_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb5( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb5_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB6( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB6_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb6( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb6_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void CUNCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cuncsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cuncsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void DORBDB1( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB1_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb1( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb1_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB2( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB2_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb2( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb2_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB3( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB3_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb3( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb3_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB4( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void DORBDB4_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void dorbdb4( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void dorbdb4_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void DORBDB5( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORBDB5_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb5( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb5_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORBDB6( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORBDB6_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb6( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb6_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void DORCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void dorcsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void dorcsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void SORBDB1( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB1_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb1( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb1_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB2( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB2_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb2( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb2_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB3( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB3_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb3( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb3_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB4( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void SORBDB4_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void sorbdb4( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void sorbdb4_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void SORBDB5( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORBDB5_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb5( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb5_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORBDB6( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORBDB6_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb6( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb6_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void SORCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void sorcsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void sorcsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void ZUNBDB1( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB1_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb1( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb1_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB2( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB2_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb2( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb2_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB3( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB3_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb3( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb3_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB4( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB4_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb4( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb4_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB5( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB5_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb5( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb5_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB6( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB6_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb6( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb6_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void ZUNCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zuncsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zuncsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void CGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void DGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void DGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void SGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void SGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void ZGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void CGEQRT( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CGEQRT_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgeqrt( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgeqrt_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void DGEQRT( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void DGEQRT_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgeqrt( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgeqrt_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void SGEQRT( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void SGEQRT_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgeqrt( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgeqrt_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void ZGEQRT( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZGEQRT_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgeqrt( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgeqrt_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void CGEQRT3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGEQRT3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void DGEQRT3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGEQRT3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void SGEQRT3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGEQRT3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void ZGEQRT3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGEQRT3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void CTPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CTPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void DTPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void DTPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void STPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void STPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void ZTPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZTPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void CTPQRT( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CTPQRT_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctpqrt( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctpqrt_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void DTPQRT( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void DTPQRT_( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtpqrt( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtpqrt_( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void STPQRT( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void STPQRT_( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stpqrt( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stpqrt_( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void ZTPQRT( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZTPQRT_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztpqrt( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztpqrt_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void CTPQRT2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void CTPQRT2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctpqrt2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctpqrt2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void DTPQRT2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void DTPQRT2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtpqrt2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtpqrt2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void STPQRT2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void STPQRT2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stpqrt2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stpqrt2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void ZTPQRT2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ZTPQRT2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztpqrt2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztpqrt2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void CBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void CBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void cbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void cbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void ZBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void ZBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void zbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void zbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void SBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void SBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void sbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void sbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void DBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void DBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void dbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void dbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void CUNBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void CUNBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void cunbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void cunbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void ZUNBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void ZUNBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void zunbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void zunbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void SORBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void SORBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void sorbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void sorbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void DORBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void DORBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void dorbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void dorbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void CUNCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void CUNCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void cuncsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void cuncsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void ZUNCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void ZUNCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void zuncsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void zuncsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void SORCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void SORCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void sorcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void sorcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void DORCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void DORCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void dorcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void dorcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void CLAPMR( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void CLAPMR_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmr( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmr_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void DLAPMR( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void DLAPMR_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmr( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmr_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void ZLAPMR( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void ZLAPMR_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmr( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmr_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void SLAPMR( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void SLAPMR_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmr( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmr_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void CSYCONV( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void CSYCONV_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void csyconv( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void csyconv_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void ZSYCONV( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void ZSYCONV_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void zsyconv( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void zsyconv_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void SSYCONV( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void SSYCONV_( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void ssyconv( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void ssyconv_( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void DSYCONV( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void DSYCONV_( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void dsyconv( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void dsyconv_( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void CSYSWAPR( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void CSYSWAPR_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void csyswapr( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void csyswapr_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void ZSYSWAPR( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void ZSYSWAPR_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zsyswapr( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zsyswapr_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void SSYSWAPR( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void SSYSWAPR_( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void ssyswapr( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void ssyswapr_( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void DSYSWAPR( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void DSYSWAPR_( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void dsyswapr( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void dsyswapr_( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void CSYTRI2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void ZSYTRI2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void SSYTRI2( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI2_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri2( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri2_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void DSYTRI2( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI2_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri2( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri2_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void CSYTRI2X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void CSYTRI2X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void csytri2x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void csytri2x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void ZSYTRI2X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void ZSYTRI2X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void zsytri2x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void zsytri2x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void SSYTRI2X( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void SSYTRI2X_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void ssytri2x( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void ssytri2x_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void DSYTRI2X( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void DSYTRI2X_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void dsytri2x( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void dsytri2x_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void SLARTGP( float* f, float* g, float* cs, float* sn, float* r ); void SLARTGP_( float* f, float* g, float* cs, float* sn, float* r ); void slartgp( float* f, float* g, float* cs, float* sn, float* r ); void slartgp_( float* f, float* g, float* cs, float* sn, float* r ); void DLARTGP( double* f, double* g, double* cs, double* sn, double* r ); void DLARTGP_( double* f, double* g, double* cs, double* sn, double* r ); void dlartgp( double* f, double* g, double* cs, double* sn, double* r ); void dlartgp_( double* f, double* g, double* cs, double* sn, double* r ); void SLARTGS( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void SLARTGS_( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void slartgs( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void slartgs_( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void DLARTGS( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void DLARTGS_( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void dlartgs( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void dlartgs_( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void CSYTRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CSYTRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void csytrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void csytrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ZSYTRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZSYTRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zsytrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zsytrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void SSYTRS2( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void SSYTRS2_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void ssytrs2( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void ssytrs2_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void DSYTRS2( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void DSYTRS2_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void dsytrs2( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void dsytrs2_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void CHETRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CHETRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void chetrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void chetrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ZHETRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZHETRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zhetrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zhetrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void CBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void CBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void cbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void cbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void CGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void CGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void cgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void cgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void CGBCON( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgbcon( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequb( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequb_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBEQU( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequ( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequ_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBTF2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTF2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtf2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtf2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTRF( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTRF_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtrf( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtrf_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGEBAL( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void CGEBAL_( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void cgebal( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void cgebal_( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void CGEBD2( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void CGEBD2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void cgebd2( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void cgebd2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void CGEBRD( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void CGEBRD_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void cgebrd( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void cgebrd_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void CGECON( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGECON_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgecon( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgecon_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGEEQUB( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEEQUB_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequb( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequb_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEEQU( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEEQU_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequ( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequ_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEES( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEES_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgees( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgees_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEESX( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEESX_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgeesx( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgeesx_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGS( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGS_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegs( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegs_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegv( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegv_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEHD2( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEHD2_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgehd2( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgehd2_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEHRD( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEHRD_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgehrd( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgehrd_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGELQ2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGELQ2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgelq2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgelq2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGELQF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGELQF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgelqf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgelqf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGELSD( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGELSD_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgelsd( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgelsd_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGELS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CGELS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgels( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgels_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CGELSS( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGELSS_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelss( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelss_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGELSX( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void CGELSX_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void cgelsx( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void cgelsx_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void CGELSY( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGELSY_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelsy( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelsy_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEQL2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQL2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeql2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeql2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQLF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQLF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqlf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqlf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQP3( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEQP3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeqp3( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeqp3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEQPF( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void CGEQPF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void cgeqpf( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void cgeqpf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void CGEQR2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQR2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQR2P( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQR2P_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2p( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2p_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQRF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQRF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQRFP( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQRFP_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrfp( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrfp_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGERFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGERFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgerfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgerfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGERQ2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGERQ2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgerq2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgerq2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGERQF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGERQF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgerqf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgerqf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGESC2( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void CGESC2_( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void cgesc2( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void cgesc2_( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void CGESDD( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGESDD_( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgesdd( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgesdd_( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGESV( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGESV_( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgesv( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgesv_( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGETC2( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void CGETC2_( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void cgetc2( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void cgetc2_( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void CGETF2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETF2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetf2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetf2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETRF( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETRF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void MKL_CGETRFNPI( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void MKL_CGETRFNPI_( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnpi( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnpi_( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void CGETRI( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CGETRI_( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void cgetri( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void cgetri_( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CGETRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGETRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgetrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgetrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGGBAL( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void CGGBAL_( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void cggbal( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void cggbal_( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void CGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void CGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void cggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void cggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void CGGEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGGEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void CGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void cggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void cggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void CGGGLM( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void CGGGLM_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void cggglm( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void cggglm_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void CGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void CGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void cgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void cgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void CGGLSE( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void CGGLSE_( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void cgglse( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void cgglse_( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void CGGQRF( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGQRF_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggqrf( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggqrf_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGRQF( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGRQF_( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggrqf( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggrqf_( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void cggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void cggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGTCON( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CGTCON_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cgtcon( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cgtcon_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CGTRFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTRFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtrfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtrfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTSV( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CGTSV_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cgtsv( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cgtsv_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTTRF( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void CGTTRF_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void cgttrf( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void cgttrf_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void CGTTRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGTTRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgttrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgttrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGTTS2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void CGTTS2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void cgtts2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void cgtts2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void CHBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEV( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbev( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbev_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void CHBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void chbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void chbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void CHBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBTRD( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CHBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void chbtrd( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void chbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CHECON( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHECON_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHEEQUB( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CHEEQUB_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void cheequb( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void cheequb_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CHEEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEV( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEVR( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVR_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEGS2( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGS2_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegs2( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegs2_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGST( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGST_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegst( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegst_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chegvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chegvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chegvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chegvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHERFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHERFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cherfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cherfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHERFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHERFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cherfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cherfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHESV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHESVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chesvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chesvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHESVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHESVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void chesvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void chesvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHETD2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void CHETD2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void chetd2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void chetd2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void CHETF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETRD( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRI_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHETRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void CHFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void chfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void chfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void CHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHLA_TRANSTYPE( char* ret_val, int ret_val_len, const int* trans ); void CHLA_TRANSTYPE_( char* ret_val, int ret_val_len, const int* trans ); void chla_transtype( char* ret_val, int ret_val_len, const int* trans ); void chla_transtype_( char* ret_val, int ret_val_len, const int* trans ); void CHPCON( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHPCON_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void chpcon( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void chpcon_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHPEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpevd( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPEV( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpev( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpev_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPGST( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void CHPGST_( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void chpgst( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void chpgst_( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void CHPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpgvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpgv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpgv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chpsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chpsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chpsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chpsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPTRD( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void CHPTRD_( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void chptrd( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void chptrd_( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void CHPTRF( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CHPTRF_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void chptrf( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void chptrf_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CHPTRI( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CHPTRI_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void chptri( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void chptri_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CHPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHSEIN( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void CHSEIN_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void chsein( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void chsein_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void CHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void chseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void chseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLABRD( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void CLABRD_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void clabrd( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void clabrd_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void CLACGV( const int* n, MKL_Complex8* x, const int* incx ); void CLACGV_( const int* n, MKL_Complex8* x, const int* incx ); void clacgv( const int* n, MKL_Complex8* x, const int* incx ); void clacgv_( const int* n, MKL_Complex8* x, const int* incx ); void CLACN2( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void CLACN2_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void clacn2( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void clacn2_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void CLACON( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void CLACON_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void clacon( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void clacon_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void CLACP2( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACP2_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacp2( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacp2_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACPY( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACPY_( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacpy( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacpy_( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACRM( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLACRM_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clacrm( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clacrm_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLACRT( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void CLACRT_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void clacrt( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void clacrt_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void CLADIV( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void CLADIV_( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void cladiv( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void cladiv_( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void CLAED0( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void CLAED0_( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void claed0( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void claed0_( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void CLAED7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CLAED7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void claed7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void claed7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CLAED8( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void CLAED8_( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void claed8( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void claed8_( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void CLAEIN( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void CLAEIN_( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void claein( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void claein_( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void CLAESY( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void CLAESY_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void claesy( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void claesy_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void CLAEV2( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void CLAEV2_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void claev2( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void claev2_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void CLAG2Z( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void CLAG2Z_( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void clag2z( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void clag2z_( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void CLAGS2( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void CLAGS2_( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void clags2( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void clags2_( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void CLAGTM( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void CLAGTM_( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void clagtm( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void clagtm_( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void CLAHEF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHEF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void CLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void clahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void clahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void CLAHR2( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAHR2_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahr2( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahr2_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAHRD( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAHRD_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahrd( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahrd_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAIC1( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void CLAIC1_( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void claic1( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void claic1_( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void CLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void CLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void clals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void clals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void CLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void CLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void clalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void clalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void CLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void clalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void clalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); float CLANGB( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float clangb( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float clangb_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANGE( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANGE_( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clange( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clange_( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANGT( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float CLANGT_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float clangt( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float clangt_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float CLANHB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANHB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clanhb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clanhb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANHE( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHE_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhe( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhe_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHF( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float CLANHF_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float clanhf( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float clanhf_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float CLANHP( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANHP_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clanhp( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clanhp_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANHS( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHS_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhs( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhs_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHT( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float CLANHT_( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float clanht( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float clanht_( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float CLANSB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clansb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clansb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANSP( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANSP_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clansp( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clansp_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANSY( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANSY_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clansy( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clansy_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float CLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float clantp( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float clantp_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float CLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); void CLAPLL( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void CLAPLL_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void clapll( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void clapll_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void CLAPMT( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void CLAPMT_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmt( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmt_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void CLAQGB( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQGB_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqgb( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqgb_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQGE( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQGE_( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqge( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqge_( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQHB( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void CLAQHB_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void claqhb( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void claqhb_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void CLAQHE( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAQHE_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqhe( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqhe_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAQHP( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQHP_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqhp( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqhp_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQP2( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void CLAQP2_( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void claqp2( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void claqp2_( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void CLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void CLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void claqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void claqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void CLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR1( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void CLAQR1_( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void claqr1( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void claqr1_( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void CLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void CLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void claqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void claqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void CLAQSB( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSB_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void claqsb( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void claqsb_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSP( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSP_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqsp( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqsp_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSY( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSY_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqsy( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqsy_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAR1V( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void CLAR1V_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void clar1v( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void clar1v_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void CLAR2V( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void CLAR2V_( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void clar2v( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void clar2v_( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void CLARCM( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLARCM_( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clarcm( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clarcm_( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARF( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARF_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarf( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarf_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARFG( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFG_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfg( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfg_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFGP( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFGP_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfgp( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfgp_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFP( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFP_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfp( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfp_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFT( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLARFT_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarft( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarft_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLARFX( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARFX_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfx( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfx_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARGV( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void CLARGV_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void clargv( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void clargv_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void CLARNV( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void CLARNV_( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void clarnv( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void clarnv_( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void CLARRV( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void CLARRV_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void clarrv( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void clarrv_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void CLARSCL2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLARSCL2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clarscl2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clarscl2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLARTG( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void CLARTG_( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void clartg( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void clartg_( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void CLARTV( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void CLARTV_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void clartv( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void clartv_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void CLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARZ( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARZ_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarz( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarz_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARZT( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLARZT_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarzt( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarzt_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLASCL( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLASCL_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clascl( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clascl_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLASCL2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLASCL2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clascl2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clascl2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLASET( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void CLASET_( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void claset( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void claset_( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void CLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void CLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void clasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void clasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void CLASSQ( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void CLASSQ_( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void classq( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void classq_( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void CLASWP( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void CLASWP_( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void claswp( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void claswp_( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void CLASYF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATDF( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void CLATDF_( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void clatdf( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void clatdf_( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void CLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATRD( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void CLATRD_( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void clatrd( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void clatrd_( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void CLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATRZ( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void CLATRZ_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void clatrz( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void clatrz_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void CLATZM( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void CLATZM_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void clatzm( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void clatzm_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void CLAUU2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLAUU2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauu2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauu2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLAUUM( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLAUUM_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauum( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauum_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPBCON( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPBCON_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpbcon( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpbcon_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPBEQU( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void CPBEQU_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void cpbequ( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void cpbequ_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void CPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBSTF( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBSTF_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbstf( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbstf_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBTF2( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTF2_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtf2( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtf2_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTRF( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTRF_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtrf( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtrf_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPFTRF( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRF_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftrf( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftrf_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRI( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRI_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftri( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftri_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void CPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void cpftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void cpftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void CPOCON( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPOCON_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpocon( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpocon_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPOEQUB( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPOEQUB_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequb( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequb_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPOEQU( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPOEQU_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequ( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequ_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPORFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPORFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cporfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cporfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPOSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPOSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cposv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cposv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPOTF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRI( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRI_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotri( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotri_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPOTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cpotrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cpotrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPPCON( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPPCON_( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cppcon( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cppcon_( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPPEQU( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void CPPEQU_( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void cppequ( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void cppequ_( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void CPPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cppsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cppsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPTRF( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRF_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptrf( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptrf_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRI( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRI_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptri( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptri_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cpptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cpptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPSTF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPSTF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPSTRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPSTRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPTCON( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void CPTCON_( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void cptcon( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void cptcon_( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void CPTEQR( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CPTEQR_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void cpteqr( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void cpteqr_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CPTRFS( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTRFS_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptrfs( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptrfs_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTSV( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTSV_( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cptsv( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cptsv_( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTSVX( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTSVX_( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptsvx( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptsvx_( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTTRF( const int* n, float* d, MKL_Complex8* e, int* info ); void CPTTRF_( const int* n, float* d, MKL_Complex8* e, int* info ); void cpttrf( const int* n, float* d, MKL_Complex8* e, int* info ); void cpttrf_( const int* n, float* d, MKL_Complex8* e, int* info ); void CPTTRS( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTTRS_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cpttrs( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cpttrs_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTTS2( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void CPTTS2_( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void cptts2( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void cptts2_( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void CROT( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void CROT_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void crot( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void crot_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void CSPCON( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSPCON_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cspcon( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cspcon_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSPMV( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSPMV_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void cspmv( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void cspmv_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSPR( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void CSPR_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void cspr( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void cspr_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void CSPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cspsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cspsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPTRF( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CSPTRF_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void csptrf( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void csptrf_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CSPTRI( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CSPTRI_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void csptri( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void csptri_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CSPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSRSCL( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void CSRSCL_( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void csrscl( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void csrscl_( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void CSTEDC( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CSTEDC_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cstedc( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cstedc_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CSTEGR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEGR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstegr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstegr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEIN( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void CSTEIN_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void cstein( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void cstein_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void CSTEMR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEMR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstemr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstemr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEQR( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CSTEQR_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void csteqr( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void csteqr_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CSYCON( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCON_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYEQUB( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CSYEQUB_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void csyequb( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void csyequb_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CSYMV( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSYMV_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void csymv( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void csymv_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSYR( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void CSYR_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void csyr( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void csyr_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void CSYRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSYRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csyrfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csyrfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void csysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void csysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYTF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRI_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CTBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CTBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void ctbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void ctbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CTFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void CTFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void ctfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void ctfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void CTFTRI( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void CTFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void ctftri( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void ctftri_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void CTFTTP( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void CTFTTP_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void ctfttp( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void ctfttp_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void CTFTTR( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void CTFTTR_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void ctfttr( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void ctfttr_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void CTGEVC( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTGEVC_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctgevc( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctgevc_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTGEX2( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void CTGEX2_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void ctgex2( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void ctgex2_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void CTGEXC( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void CTGEXC_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ctgexc( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ctgexc_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void CTGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CTGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ctgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ctgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CTGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void CTGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void ctgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void ctgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void CTGSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTGSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTGSY2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void CTGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void ctgsy2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void ctgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void CTGSYL( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsyl( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTPCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctpcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTPTRI( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void CTPTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void ctptri( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void ctptri_( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void CTPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CTPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void ctptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void ctptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CTPTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void CTPTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void ctpttf( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void ctpttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void CTPTTR( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void CTPTTR_( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void ctpttr( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void ctpttr_( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void CTRCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctrcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctrcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTREVC( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTREVC_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctrevc( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctrevc_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTREXC( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void CTREXC_( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ctrexc( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ctrexc_( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void CTRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctrrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctrrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTRSEN( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void CTRSEN_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void ctrsen( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void ctrsen_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void CTRSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void CTRSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void ctrsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void ctrsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void CTRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void CTRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void ctrsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void ctrsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void CTRTI2( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTI2_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrti2( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrti2_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTRI( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrtri( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrtri_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CTRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void ctrtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void ctrtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CTRTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void CTRTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void ctrttf( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void ctrttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void CTRTTP( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void CTRTTP_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void ctrttp( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void ctrttp_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void CTZRQF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void CTZRQF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void ctzrqf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void ctzrqf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void CTZRZF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CTZRZF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void ctzrzf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void ctzrzf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNG2L( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNG2L_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2l( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2l_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNG2R( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNG2R_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2r( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2r_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGBR( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGBR_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungbr( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungbr_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGHR( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGHR_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunghr( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunghr_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGL2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGL2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungl2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungl2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGLQ( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGLQ_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunglq( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunglq_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQL( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQL_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungql( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungql_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQR( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQR_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungqr( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungqr_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGR2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGR2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungr2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungr2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGRQ( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGRQ_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungrq( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungrq_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGTR( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGTR_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungtr( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungtr_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmql( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUPGTR( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CUPGTR_( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void cupgtr( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void cupgtr_( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CUPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cupmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cupmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void DBDSDC( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void DBDSDC_( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void dbdsdc( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void dbdsdc_( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void DBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DDISNA( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void DDISNA_( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void ddisna( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void ddisna_( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void DGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void DGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void dgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void dgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void DGBCON( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgbcon( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequb( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequb_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBEQU( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequ( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequ_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void DGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void dgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void dgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void DGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBTF2( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTF2_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtf2( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtf2_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTRF( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTRF_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtrf( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtrf_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void DGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void dgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void dgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void DGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void DGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void dgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void dgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void DGEBAL( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void DGEBAL_( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void dgebal( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void dgebal_( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void DGEBD2( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void DGEBD2_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void dgebd2( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void dgebd2_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void DGEBRD( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void DGEBRD_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void dgebrd( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void dgebrd_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void DGECON( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGECON_( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgecon( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgecon_( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGEEQUB( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEEQUB_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequb( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequb_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEEQU( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEEQU_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequ( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequ_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEES( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void DGEES_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void dgees( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void dgees_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void DGEESX( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGEESX_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dgeesx( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dgeesx_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGEEV( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEEV_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgeev( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgeev_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void DGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void dgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void dgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void DGEGS( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void DGEGS_( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void dgegs( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void dgegs_( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void DGEGV( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEGV_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgegv( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgegv_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEHD2( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void DGEHD2_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void dgehd2( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void dgehd2_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void DGEHRD( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEHRD_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgehrd( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgehrd_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEJSV( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void DGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void dgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void dgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void DGELQ2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGELQ2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgelq2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgelq2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGELQF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGELQF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgelqf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgelqf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGELSD( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void DGELSD_( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void dgelsd( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void dgelsd_( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void DGELS( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DGELS_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgels( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgels_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DGELSS( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGELSS_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelss( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelss_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGELSX( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void DGELSX_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void dgelsx( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void dgelsx_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void DGELSY( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGELSY_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelsy( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelsy_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGEQL2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQL2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeql2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeql2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQLF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQLF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqlf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqlf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQP3( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void DGEQP3_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void dgeqp3( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void dgeqp3_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void DGEQPF( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void DGEQPF_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void dgeqpf( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void dgeqpf_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void DGEQR2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQR2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQR2P( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQR2P_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2p( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2p_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQRF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQRF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQRFP( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQRFP_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrfp( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrfp_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGERFS( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGERFS_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgerfs( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgerfs_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGERQ2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGERQ2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgerq2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgerq2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGERQF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGERQF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgerqf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgerqf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGESC2( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void DGESC2_( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void dgesc2( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void dgesc2_( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void DGESDD( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void DGESDD_( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesdd( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesdd_( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void DGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void DGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void dgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void dgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void DGESV( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void DGESV_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void dgesv( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void dgesv_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void DGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void DGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void dgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void dgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void DGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGETC2( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void DGETC2_( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void dgetc2( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void dgetc2_( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void DGETF2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETF2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetf2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetf2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETRF( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETRF_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void MKL_DGETRFNPI( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void MKL_DGETRFNPI_( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void mkl_dgetrfnpi( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void mkl_dgetrfnpi_( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void DGETRI( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void DGETRI_( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dgetri( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dgetri_( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void DGETRS( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DGETRS_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dgetrs( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dgetrs_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void DGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void dggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void dggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void DGGBAL( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void DGGBAL_( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void dggbal( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void dggbal_( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void DGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void DGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void DGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGGEV( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGGEV_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void DGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void dggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void dggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void DGGGLM( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void DGGGLM_( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void dggglm( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void dggglm_( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void DGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void DGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void dgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void dgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void DGGLSE( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void DGGLSE_( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void dgglse( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void dgglse_( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void DGGQRF( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGQRF_( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggqrf( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggqrf_( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGRQF( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGRQF_( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggrqf( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggrqf_( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void DGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void dggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void dggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void DGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void DGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void dggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void dggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void DGSVJ0( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGSVJ0_( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj0( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj0_( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj1( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGTCON( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGTCON_( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgtcon( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgtcon_( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGTRFS( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTRFS_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtrfs( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtrfs_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTSV( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void DGTSV_( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void dgtsv( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void dgtsv_( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void DGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTTRF( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void DGTTRF_( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void dgttrf( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void dgttrf_( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void DGTTRS( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void DGTTRS_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void dgttrs( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void dgttrs_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void DGTTS2( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void DGTTS2_( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void dgtts2( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void dgtts2_( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void DHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DHSEIN( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void DHSEIN_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void dhsein( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void dhsein_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void DHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); int DISNAN( const double* din ); int DISNAN_( const double* din ); int disnan( const double* din ); int disnan_( const double* din ); void DLABAD( double* smallx, double* large ); void DLABAD_( double* smallx, double* large ); void dlabad( double* smallx, double* large ); void dlabad_( double* smallx, double* large ); void DLABRD( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void DLABRD_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void dlabrd( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void dlabrd_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void DLACN2( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void DLACN2_( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void dlacn2( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void dlacn2_( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void DLACON( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void DLACON_( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void dlacon( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void dlacon_( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void DLACPY( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void DLACPY_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void dlacpy( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void dlacpy_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void DLADIV( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void DLADIV_( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void dladiv( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void dladiv_( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void DLAE2( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void DLAE2_( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void dlae2( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void dlae2_( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void DLAEBZ( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void DLAEBZ_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void dlaebz( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void dlaebz_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void DLAED0( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void DLAED0_( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void dlaed0( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void dlaed0_( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void DLAED1( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void DLAED1_( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void dlaed1( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void dlaed1_( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void DLAED2( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void DLAED2_( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void dlaed2( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void dlaed2_( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void DLAED3( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void DLAED3_( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void dlaed3( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void dlaed3_( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void DLAED4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void DLAED4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void dlaed4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void dlaed4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void DLAED5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void DLAED5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void dlaed5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void dlaed5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void DLAED6( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void DLAED6_( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void dlaed6( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void dlaed6_( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void DLAED7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void DLAED7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void dlaed7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void dlaed7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void DLAED8( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void DLAED8_( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void dlaed8( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void dlaed8_( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void DLAED9( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void DLAED9_( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void dlaed9( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void dlaed9_( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void DLAEDA( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void DLAEDA_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void dlaeda( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void dlaeda_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void DLAEIN( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void DLAEIN_( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void dlaein( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void dlaein_( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void DLAEV2( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void DLAEV2_( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void dlaev2( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void dlaev2_( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void DLAEXC( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void DLAEXC_( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void dlaexc( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void dlaexc_( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void DLAG2( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void DLAG2_( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void dlag2( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void dlag2_( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void DLAG2S( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLAG2S_( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlag2s( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlag2s_( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLAGS2( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void DLAGS2_( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void dlags2( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void dlags2_( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void DLAGTF( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void DLAGTF_( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void dlagtf( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void dlagtf_( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void DLAGTM( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void DLAGTM_( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void dlagtm( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void dlagtm_( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void DLAGTS( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void DLAGTS_( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void dlagts( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void dlagts_( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void DLAGV2( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void DLAGV2_( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void dlagv2( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void dlagv2_( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void DLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void DLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void dlahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void dlahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void DLAHR2( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAHR2_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahr2( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahr2_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAHRD( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAHRD_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahrd( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahrd_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAIC1( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); void DLAIC1_( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); void dlaic1( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); void dlaic1_( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); int DLAISNAN( const double* din1, const double* din2 ); int DLAISNAN_( const double* din1, const double* din2 ); int dlaisnan( const double* din1, const double* din2 ); int dlaisnan_( const double* din1, const double* din2 ); void DLALN2( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void DLALN2_( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void dlaln2( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void dlaln2_( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void DLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void DLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void dlals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void dlals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void DLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void DLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void dlalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void dlalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void DLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); void DLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); void dlalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); void dlalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); double DLAMCH( const char* cmach ); double DLAMCH_( const char* cmach ); double dlamch( const char* cmach ); double dlamch_( const char* cmach ); void DLAMC1( int* beta, int* t, int* rnd, int* ieee1 ); void DLAMC1_( int* beta, int* t, int* rnd, int* ieee1 ); void dlamc1( int* beta, int* t, int* rnd, int* ieee1 ); void dlamc1_( int* beta, int* t, int* rnd, int* ieee1 ); void DLAMC2( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); void DLAMC2_( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); void dlamc2( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); void dlamc2_( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); double DLAMC3( const double* a, const double* b ); double DLAMC3_( const double* a, const double* b ); double dlamc3( const double* a, const double* b ); double dlamc3_( const double* a, const double* b ); void DLAMC4( int* emin, const double* start, const int* base ); void DLAMC4_( int* emin, const double* start, const int* base ); void dlamc4( int* emin, const double* start, const int* base ); void dlamc4_( int* emin, const double* start, const int* base ); void DLAMC5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void DLAMC5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void dlamc5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void dlamc5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void DLAMRG( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); void DLAMRG_( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); void dlamrg( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); void dlamrg_( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); int DLANEG( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); int DLANEG_( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); int dlaneg( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); int dlaneg_( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); double DLANGB( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double DLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double dlangb( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double dlangb_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double DLANGE( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double DLANGE_( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlange( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlange_( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double DLANGT( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double DLANGT_( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double dlangt( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double dlangt_( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double DLANHS( const char* norm, const int* n, const double* a, const int* lda, double* work ); double DLANHS_( const char* norm, const int* n, const double* a, const int* lda, double* work ); double dlanhs( const char* norm, const int* n, const double* a, const int* lda, double* work ); double dlanhs_( const char* norm, const int* n, const double* a, const int* lda, double* work ); double DLANSB( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlansb( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlansb_( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANSF( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double DLANSF_( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double dlansf( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double dlansf_( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double DLANSP( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double DLANSP_( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double dlansp( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double dlansp_( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double DLANST( const char* norm, const int* n, const double* d, const double* e ); double DLANST_( const char* norm, const int* n, const double* d, const double* e ); double dlanst( const char* norm, const int* n, const double* d, const double* e ); double dlanst_( const char* norm, const int* n, const double* d, const double* e ); double DLANSY( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double DLANSY_( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double dlansy( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double dlansy_( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double DLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double DLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double dlantp( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double dlantp_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double DLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); double DLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); void DLANV2( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void DLANV2_( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void dlanv2( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void dlanv2_( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void DLAPLL( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void DLAPLL_( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void dlapll( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void dlapll_( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void DLAPMT( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void DLAPMT_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmt( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmt_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); double DLAPY2( const double* x, const double* y ); double DLAPY2_( const double* x, const double* y ); double dlapy2( const double* x, const double* y ); double dlapy2_( const double* x, const double* y ); double DLAPY3( const double* x, const double* y, const double* z ); double DLAPY3_( const double* x, const double* y, const double* z ); double dlapy3( const double* x, const double* y, const double* z ); double dlapy3_( const double* x, const double* y, const double* z ); void DLAQGB( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQGB_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqgb( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqgb_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQGE( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQGE_( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqge( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqge_( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQP2( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void DLAQP2_( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void dlaqp2( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void dlaqp2_( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void DLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void DLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void dlaqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void dlaqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void DLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR1( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void DLAQR1_( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void dlaqr1( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void dlaqr1_( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void DLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void DLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void dlaqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void dlaqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void DLAQSB( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSB_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsb( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsb_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSP( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSP_( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsp( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsp_( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSY( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSY_( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsy( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsy_( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void DLAQTR( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void DLAQTR_( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void dlaqtr( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void dlaqtr_( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void DLAR1V( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void DLAR1V_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void dlar1v( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void dlar1v_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void DLAR2V( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void DLAR2V_( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void dlar2v( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void dlar2v_( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void DLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARF( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARF_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarf( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarf_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARFG( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFG_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfg( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfg_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFGP( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFGP_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfgp( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfgp_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFP( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFP_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfp( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfp_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFT( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLARFT_( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarft( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarft_( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLARFX( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void DLARFX_( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void dlarfx( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void dlarfx_( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void DLARGV( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void DLARGV_( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void dlargv( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void dlargv_( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void DLARNV( const int* idist, int* iseed, const int* n, double* x ); void DLARNV_( const int* idist, int* iseed, const int* n, double* x ); void dlarnv( const int* idist, int* iseed, const int* n, double* x ); void dlarnv_( const int* idist, int* iseed, const int* n, double* x ); void DLARRA( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void DLARRA_( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void dlarra( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void dlarra_( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void DLARRB( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void DLARRB_( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void dlarrb( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void dlarrb_( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void DLARRC( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void DLARRC_( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void dlarrc( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void dlarrc_( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void DLARRD( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void DLARRD_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void dlarrd( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void dlarrd_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void DLARRE( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void DLARRE_( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void dlarre( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void dlarre_( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void DLARRF( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void DLARRF_( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void dlarrf( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void dlarrf_( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void DLARRJ( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void DLARRJ_( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void dlarrj( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void dlarrj_( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void DLARRK( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void DLARRK_( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void dlarrk( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void dlarrk_( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void DLARRR( const int* n, const double* d, double* e, int* info ); void DLARRR_( const int* n, const double* d, double* e, int* info ); void dlarrr( const int* n, const double* d, double* e, int* info ); void dlarrr_( const int* n, const double* d, double* e, int* info ); void DLARRV( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void DLARRV_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void dlarrv( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void dlarrv_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void DLARSCL2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLARSCL2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlarscl2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlarscl2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLARTG( const double* f, const double* g, double* cs, double* sn, double* r ); void DLARTG_( const double* f, const double* g, double* cs, double* sn, double* r ); void dlartg( const double* f, const double* g, double* cs, double* sn, double* r ); void dlartg_( const double* f, const double* g, double* cs, double* sn, double* r ); void DLARTV( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void DLARTV_( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void dlartv( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void dlartv_( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void DLARUV( int* iseed, const int* n, double* x ); void DLARUV_( int* iseed, const int* n, double* x ); void dlaruv( int* iseed, const int* n, double* x ); void dlaruv_( int* iseed, const int* n, double* x ); void DLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARZ( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARZ_( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarz( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarz_( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARZT( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLARZT_( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarzt( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarzt_( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLAS2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void DLAS2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void dlas2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void dlas2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void DLASCL( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void DLASCL_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void dlascl( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void dlascl_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void DLASCL2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLASCL2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlascl2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlascl2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLASD0( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void DLASD0_( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void dlasd0( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void dlasd0_( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void DLASD1( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void DLASD1_( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void dlasd1( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void dlasd1_( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void DLASD2( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void DLASD2_( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void dlasd2( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void dlasd2_( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void DLASD3( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void DLASD3_( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void dlasd3( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void dlasd3_( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void DLASD4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void DLASD4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void dlasd4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void dlasd4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void DLASD5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void DLASD5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void dlasd5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void dlasd5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void DLASD6( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void DLASD6_( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void dlasd6( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void dlasd6_( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void DLASD7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void DLASD7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void dlasd7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void dlasd7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void DLASD8( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void DLASD8_( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void dlasd8( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void dlasd8_( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void DLASDA( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void DLASDA_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void dlasda( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void dlasda_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void DLASDQ( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DLASDQ_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dlasdq( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dlasdq_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DLASDT( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void DLASDT_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void dlasdt( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void dlasdt_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void DLASET( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void DLASET_( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void dlaset( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void dlaset_( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void DLASQ1( const int* n, double* d, double* e, double* work, int* info ); void DLASQ1_( const int* n, double* d, double* e, double* work, int* info ); void dlasq1( const int* n, double* d, double* e, double* work, int* info ); void dlasq1_( const int* n, double* d, double* e, double* work, int* info ); void DLASQ2( const int* n, double* z, int* info ); void DLASQ2_( const int* n, double* z, int* info ); void dlasq2( const int* n, double* z, int* info ); void dlasq2_( const int* n, double* z, int* info ); void DLASQ3( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void DLASQ3_( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void dlasq3( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void dlasq3_( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void DLASQ4( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void DLASQ4_( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void dlasq4( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void dlasq4_( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void DLASQ5( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void DLASQ5_( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void dlasq5( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void dlasq5_( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void DLASQ6( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void DLASQ6_( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void dlasq6( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void dlasq6_( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void DLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void DLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void dlasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void dlasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void DLASRT( const char* id, const int* n, double* d, int* info ); void DLASRT_( const char* id, const int* n, double* d, int* info ); void dlasrt( const char* id, const int* n, double* d, int* info ); void dlasrt_( const char* id, const int* n, double* d, int* info ); void DLASSQ( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void DLASSQ_( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void dlassq( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void dlassq_( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void DLASV2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void DLASV2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void dlasv2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void dlasv2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void DLASWP( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void DLASWP_( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void dlaswp( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void dlaswp_( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void DLASY2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void DLASY2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void dlasy2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void dlasy2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void DLASYF( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DLASYF_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DLAT2S( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLAT2S_( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlat2s( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlat2s_( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void DLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void dlatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void dlatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void DLATDF( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void DLATDF_( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void dlatdf( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void dlatdf_( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void DLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void DLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void dlatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void dlatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void DLATRD( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void DLATRD_( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void dlatrd( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void dlatrd_( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void DLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void DLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void dlatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void dlatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void DLATRZ( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void DLATRZ_( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void dlatrz( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void dlatrz_( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void DLATZM( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void DLATZM_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void dlatzm( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void dlatzm_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void DLAUU2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DLAUU2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauu2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauu2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DLAUUM( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DLAUUM_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauum( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauum_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DOPGTR( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void DOPGTR_( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void dopgtr( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void dopgtr_( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void DOPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void DOPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void dopmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void dopmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORG2L( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORG2L_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2l( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2l_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORG2R( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORG2R_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2r( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2r_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGBR( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGBR_( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgbr( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgbr_( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGHR( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGHR_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorghr( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorghr_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGL2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGL2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgl2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgl2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGLQ( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGLQ_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorglq( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorglq_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQL( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQL_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgql( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgql_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQR( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQR_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgqr( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgqr_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGR2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGR2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgr2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgr2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGRQ( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGRQ_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgrq( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgrq_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGTR( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGTR_( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgtr( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgtr_( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormql( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DPBCON( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPBCON_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpbcon( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpbcon_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPBEQU( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void DPBEQU_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void dpbequ( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void dpbequ_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void DPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBSTF( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBSTF_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbstf( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbstf_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBTF2( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTF2_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtf2( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtf2_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTRF( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTRF_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtrf( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtrf_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPFTRF( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRF_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftrf( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftrf_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRI( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRI_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftri( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftri_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void DPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void dpftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void dpftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void DPOCON( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPOCON_( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpocon( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpocon_( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPOEQUB( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPOEQUB_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequb( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequb_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPOEQU( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPOEQU_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequ( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequ_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPORFS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPORFS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dporfs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dporfs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPOSV( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void DPOSV_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void dposv( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void dposv_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void DPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPOTF2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTF2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotf2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotf2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRF( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRF_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRI( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRI_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotri( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotri_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DPOTRS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dpotrs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dpotrs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DPPCON( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPPCON_( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dppcon( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dppcon_( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPPEQU( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void DPPEQU_( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void dppequ( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void dppequ_( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void DPPRFS( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPRFS_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpprfs( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpprfs_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPSV( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void DPPSV_( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void dppsv( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void dppsv_( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void DPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPTRF( const char* uplo, const int* n, double* ap, int* info ); void DPPTRF_( const char* uplo, const int* n, double* ap, int* info ); void dpptrf( const char* uplo, const int* n, double* ap, int* info ); void dpptrf_( const char* uplo, const int* n, double* ap, int* info ); void DPPTRI( const char* uplo, const int* n, double* ap, int* info ); void DPPTRI_( const char* uplo, const int* n, double* ap, int* info ); void dpptri( const char* uplo, const int* n, double* ap, int* info ); void dpptri_( const char* uplo, const int* n, double* ap, int* info ); void DPPTRS( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DPPTRS_( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dpptrs( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dpptrs_( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DPSTF2( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPSTF2_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstf2( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstf2_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPSTRF( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPSTRF_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstrf( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstrf_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPTCON( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void DPTCON_( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void dptcon( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void dptcon_( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void DPTEQR( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DPTEQR_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dpteqr( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dpteqr_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DPTRFS( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void DPTRFS_( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void dptrfs( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void dptrfs_( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void DPTSV( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void DPTSV_( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void dptsv( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void dptsv_( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void DPTSVX( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void DPTSVX_( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void dptsvx( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void dptsvx_( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void DPTTRF( const int* n, double* d, double* e, int* info ); void DPTTRF_( const int* n, double* d, double* e, int* info ); void dpttrf( const int* n, double* d, double* e, int* info ); void dpttrf_( const int* n, double* d, double* e, int* info ); void DPTTRS( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void DPTTRS_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void dpttrs( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void dpttrs_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void DPTTS2( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void DPTTS2_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void dptts2( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void dptts2_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void DRSCL( const int* n, const double* sa, double* sx, const int* incx ); void DRSCL_( const int* n, const double* sa, double* sx, const int* incx ); void drscl( const int* n, const double* sa, double* sx, const int* incx ); void drscl_( const int* n, const double* sa, double* sx, const int* incx ); void DSBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEV( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void DSBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void dsbev( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void dsbev_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void DSBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void DSBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void dsbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void dsbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void DSBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void DSBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void dsbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void dsbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void DSBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBTRD( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); void DSBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); void dsbtrd( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); void dsbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); double DSECND( void ); double DSECND_( void ); double dsecnd( void ); double dsecnd_( void ); void DSFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void DSFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void dsfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void dsfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void DSGESV( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSGESV_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsgesv( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsgesv_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSPCON( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSPCON_( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dspcon( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dspcon_( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSPEVD( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPEVD_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspevd( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspevd_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPEV( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void DSPEV_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void dspev( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void dspev_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void DSPEVX( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspevx( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspevx_( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPGST( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void DSPGST_( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void dspgst( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void dspgst_( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void DSPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspgvd( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPGV( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void DSPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void dspgv( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void dspgv_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void DSPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPOSV( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSPOSV_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsposv( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsposv_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSPRFS( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPRFS_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsprfs( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsprfs_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPSV( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void DSPSV_( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void dspsv( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void dspsv_( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void DSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPTRD( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void DSPTRD_( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void dsptrd( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void dsptrd_( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void DSPTRF( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void DSPTRF_( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void dsptrf( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void dsptrf_( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void DSPTRI( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void DSPTRI_( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void dsptri( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void dsptri_( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void DSPTRS( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void DSPTRS_( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void dsptrs( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void dsptrs_( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void DSTEBZ( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void DSTEBZ_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void dstebz( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void dstebz_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void DSTEDC( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEDC_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstedc( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstedc_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEGR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEGR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstegr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstegr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEIN( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSTEIN_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstein( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstein_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSTEMR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEMR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstemr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstemr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEQR( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTEQR_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dsteqr( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dsteqr_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTERF( const int* n, double* d, double* e, int* info ); void DSTERF_( const int* n, double* d, double* e, int* info ); void dsterf( const int* n, double* d, double* e, int* info ); void dsterf_( const int* n, double* d, double* e, int* info ); void DSTEVD( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEVD_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevd( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevd_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEV( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTEV_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dstev( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dstev_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTEVR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEVR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEVX( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSTEVX_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstevx( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstevx_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSYCON( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCON_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYEQUB( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void DSYEQUB_( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void dsyequb( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void dsyequb_( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void DSYEVD( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVD_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEV( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEV_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEVR( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVR_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVX( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYEVX_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYGS2( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGS2_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygs2( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygs2_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGST( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGST_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygst( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygst_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGVD( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsygvd( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsygvd_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYGV( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYGV_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsygvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsygvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYRFS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSYRFS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsyrfs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsyrfs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYSV( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void DSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void dsysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void dsysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void DSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYTD2( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void DSYTD2_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void dsytd2( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void dsytd2_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void DSYTF2( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTF2_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTRD( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void DSYTRD_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void dsytrd( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void dsytrd_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void DSYTRF( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRI_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DSYTRS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DTBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void DTBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void dtbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void dtbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void DTBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DTBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dtbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dtbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DTFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void DTFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void dtfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void dtfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void DTFTRI( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void DTFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void dtftri( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void dtftri_( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void DTFTTP( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void DTFTTP_( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void dtfttp( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void dtfttp_( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void DTFTTR( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void DTFTTR_( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void dtfttr( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void dtfttr_( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void DTGEVC( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTGEVC_( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtgevc( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtgevc_( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTGEX2( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void DTGEX2_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void dtgex2( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void dtgex2_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void DTGEXC( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void DTGEXC_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void dtgexc( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void dtgexc_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void DTGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void DTGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void dtgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void dtgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void DTGSNA( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void DTGSNA_( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void dtgsna( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void dtgsna_( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void DTGSY2( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void DTGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void dtgsy2( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void dtgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void DTGSYL( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void DTGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void dtgsyl( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void dtgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void DTPCON( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void DTPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void dtpcon( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void dtpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void DTPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTPTRI( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void DTPTRI_( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void dtptri( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void dtptri_( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void DTPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DTPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dtptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dtptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DTPTTF( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void DTPTTF_( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void dtpttf( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void dtpttf_( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void DTPTTR( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void DTPTTR_( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void dtpttr( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void dtpttr_( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void DTRCON( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void DTRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void dtrcon( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void dtrcon_( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void DTREVC( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTREVC_( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtrevc( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtrevc_( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTREXC( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void DTREXC_( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void dtrexc( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void dtrexc_( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void DTRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtrrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtrrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTRSEN( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTRSEN_( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtrsen( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtrsen_( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTRSNA( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void DTRSNA_( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void dtrsna( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void dtrsna_( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void DTRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void DTRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void dtrsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void dtrsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void DTRTI2( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTI2_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrti2( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrti2_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTRI( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTRI_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrtri( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrtri_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DTRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dtrtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dtrtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DTRTTF( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void DTRTTF_( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void dtrttf( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void dtrttf_( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void DTRTTP( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void DTRTTP_( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void dtrttp( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void dtrttp_( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void DTZRQF( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void DTZRQF_( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void dtzrqf( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void dtzrqf_( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void DTZRZF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DTZRZF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dtzrzf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dtzrzf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); double DZSUM1( const int* n, const MKL_Complex16* cx, const int* incx ); double DZSUM1_( const int* n, const MKL_Complex16* cx, const int* incx ); double dzsum1( const int* n, const MKL_Complex16* cx, const int* incx ); double dzsum1_( const int* n, const MKL_Complex16* cx, const int* incx ); int ICMAX1( const int* n, const MKL_Complex8* cx, const int* incx ); int ICMAX1_( const int* n, const MKL_Complex8* cx, const int* incx ); int icmax1( const int* n, const MKL_Complex8* cx, const int* incx ); int icmax1_( const int* n, const MKL_Complex8* cx, const int* incx ); int IEEECK( const int* ispec, const float* zero, const float* one ); int IEEECK_( const int* ispec, const float* zero, const float* one ); int ieeeck( const int* ispec, const float* zero, const float* one ); int ieeeck_( const int* ispec, const float* zero, const float* one ); int ILACLC( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILACLC_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclc( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclc_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILACLR( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILACLR_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclr( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclr_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILADIAG( const char* diag ); int ILADIAG_( const char* diag ); int iladiag( const char* diag ); int iladiag_( const char* diag ); int ILADLC( const int* m, const int* n, const double* a, const int* lda ); int ILADLC_( const int* m, const int* n, const double* a, const int* lda ); int iladlc( const int* m, const int* n, const double* a, const int* lda ); int iladlc_( const int* m, const int* n, const double* a, const int* lda ); int ILADLR( const int* m, const int* n, const double* a, const int* lda ); int ILADLR_( const int* m, const int* n, const double* a, const int* lda ); int iladlr( const int* m, const int* n, const double* a, const int* lda ); int iladlr_( const int* m, const int* n, const double* a, const int* lda ); int ILAENV( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ILAENV_( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ilaenv( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ilaenv_( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ILAPREC( const char* prec ); int ILAPREC_( const char* prec ); int ilaprec( const char* prec ); int ilaprec_( const char* prec ); int ILASLC( const int* m, const int* n, const float* a, const int* lda ); int ILASLC_( const int* m, const int* n, const float* a, const int* lda ); int ilaslc( const int* m, const int* n, const float* a, const int* lda ); int ilaslc_( const int* m, const int* n, const float* a, const int* lda ); int ILASLR( const int* m, const int* n, const float* a, const int* lda ); int ILASLR_( const int* m, const int* n, const float* a, const int* lda ); int ilaslr( const int* m, const int* n, const float* a, const int* lda ); int ilaslr_( const int* m, const int* n, const float* a, const int* lda ); int ILATRANS( const char* trans ); int ILATRANS_( const char* trans ); int ilatrans( const char* trans ); int ilatrans_( const char* trans ); int ILAUPLO( const char* uplo ); int ILAUPLO_( const char* uplo ); int ilauplo( const char* uplo ); int ilauplo_( const char* uplo ); void ILAVER( int* vers_major, int* vers_minor, int* vers_patch ); void ILAVER_( int* vers_major, int* vers_minor, int* vers_patch ); void ilaver( int* vers_major, int* vers_minor, int* vers_patch ); void ilaver_( int* vers_major, int* vers_minor, int* vers_patch ); int ILAZLC( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ILAZLC_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlc( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlc_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ILAZLR( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ILAZLR_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlr( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlr_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int IPARMQ( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int IPARMQ_( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int iparmq( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int iparmq_( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int IZMAX1( const int* n, const MKL_Complex16* cx, const int* incx ); int IZMAX1_( const int* n, const MKL_Complex16* cx, const int* incx ); int izmax1( const int* n, const MKL_Complex16* cx, const int* incx ); int izmax1_( const int* n, const MKL_Complex16* cx, const int* incx ); int LSAMEN( const int* n, const char* ca, const char* cb ); int LSAMEN_( const int* n, const char* ca, const char* cb ); int lsamen( const int* n, const char* ca, const char* cb ); int lsamen_( const int* n, const char* ca, const char* cb ); void SBDSDC( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void SBDSDC_( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void sbdsdc( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void sbdsdc_( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void SBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void SBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void sbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void sbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); float SCSUM1( const int* n, const MKL_Complex8* cx, const int* incx ); float SCSUM1_( const int* n, const MKL_Complex8* cx, const int* incx ); float scsum1( const int* n, const MKL_Complex8* cx, const int* incx ); float scsum1_( const int* n, const MKL_Complex8* cx, const int* incx ); void SDISNA( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); void SDISNA_( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); void sdisna( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); void sdisna_( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); float SECOND( void ); float SECOND_( void ); float second( void ); float second_( void ); void SGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void SGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void sgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void sgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void SGBCON( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgbcon( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequb( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequb_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBEQU( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequ( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequ_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void SGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void sgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void sgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void SGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBTF2( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTF2_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtf2( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtf2_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTRF( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTRF_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtrf( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtrf_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void SGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void sgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void sgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void SGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void SGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void sgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void sgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void SGEBAL( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void SGEBAL_( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void sgebal( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void sgebal_( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void SGEBD2( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void SGEBD2_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void sgebd2( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void sgebd2_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void SGEBRD( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void SGEBRD_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void sgebrd( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void sgebrd_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void SGECON( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGECON_( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgecon( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgecon_( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGEEQUB( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEEQUB_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequb( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequb_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEEQU( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEEQU_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequ( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequ_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEES( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void SGEES_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void sgees( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void sgees_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void SGEESX( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGEESX_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sgeesx( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sgeesx_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGEEV( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEEV_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgeev( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgeev_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void SGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void sgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void sgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void SGEGS( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void SGEGS_( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void sgegs( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void sgegs_( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void SGEGV( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEGV_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgegv( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgegv_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEHD2( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void SGEHD2_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void sgehd2( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void sgehd2_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void SGEHRD( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEHRD_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgehrd( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgehrd_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEJSV( const char* joba, char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void SGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void sgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void sgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void SGELQ2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGELQ2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgelq2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgelq2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGELQF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGELQF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgelqf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgelqf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGELSD( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void SGELSD_( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void sgelsd( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void sgelsd_( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void SGELS( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SGELS_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgels( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgels_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SGELSS( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGELSS_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelss( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelss_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGELSX( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void SGELSX_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void sgelsx( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void sgelsx_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void SGELSY( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGELSY_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelsy( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelsy_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGEQL2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQL2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeql2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeql2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQLF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQLF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqlf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqlf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQP3( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void SGEQP3_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void sgeqp3( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void sgeqp3_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void SGEQPF( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void SGEQPF_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void sgeqpf( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void sgeqpf_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void SGEQR2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQR2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQR2P( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQR2P_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2p( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2p_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQRF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQRF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQRFP( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQRFP_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrfp( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrfp_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGERFS( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGERFS_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgerfs( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgerfs_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGERQ2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGERQ2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgerq2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgerq2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGERQF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGERQF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgerqf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgerqf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGESC2( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void SGESC2_( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void sgesc2( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void sgesc2_( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void SGESDD( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void SGESDD_( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesdd( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesdd_( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void SGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void SGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void sgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void sgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void SGESV( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void SGESV_( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void sgesv( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void sgesv_( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void SGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void SGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void sgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void sgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void SGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGETC2( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void SGETC2_( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void sgetc2( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void sgetc2_( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void SGETF2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETF2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetf2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetf2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETRF( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETRF_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void MKL_SGETRFNPI( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void MKL_SGETRFNPI_( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void mkl_sgetrfnpi( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void mkl_sgetrfnpi_( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void SGETRI( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void SGETRI_( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void sgetri( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void sgetri_( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void SGETRS( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SGETRS_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void sgetrs( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void sgetrs_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void SGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void sggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void sggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void SGGBAL( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void SGGBAL_( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void sggbal( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void sggbal_( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void SGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void SGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void SGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGGEV( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGGEV_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void SGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void sggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void sggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void SGGGLM( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void SGGGLM_( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void sggglm( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void sggglm_( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void SGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void SGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void sgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void sgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void SGGLSE( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void SGGLSE_( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void sgglse( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void sgglse_( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void SGGQRF( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGQRF_( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggqrf( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggqrf_( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGRQF( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGRQF_( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggrqf( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggrqf_( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void SGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void sggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void sggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void SGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void SGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void sggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void sggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void SGSVJ0( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGSVJ0_( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj0( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj0_( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj1( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGTCON( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGTCON_( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgtcon( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgtcon_( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGTRFS( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTRFS_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtrfs( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtrfs_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTSV( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void SGTSV_( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void sgtsv( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void sgtsv_( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void SGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTTRF( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void SGTTRF_( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void sgttrf( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void sgttrf_( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void SGTTRS( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void SGTTRS_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void sgttrs( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void sgttrs_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void SGTTS2( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void SGTTS2_( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void sgtts2( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void sgtts2_( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void SHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SHSEIN( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void SHSEIN_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void shsein( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void shsein_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void SHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); int SISNAN( const float* sin ); int SISNAN_( const float* sin ); int sisnan( const float* sin ); int sisnan_( const float* sin ); void SLABAD( float* smallx, float* large ); void SLABAD_( float* smallx, float* large ); void slabad( float* smallx, float* large ); void slabad_( float* smallx, float* large ); void SLABRD( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void SLABRD_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void slabrd( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void slabrd_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void SLACN2( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void SLACN2_( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void slacn2( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void slacn2_( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void SLACON( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void SLACON_( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void slacon( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void slacon_( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void SLACPY( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void SLACPY_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void slacpy( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void slacpy_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void SLADIV( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void SLADIV_( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void sladiv( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void sladiv_( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void SLAE2( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void SLAE2_( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void slae2( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void slae2_( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void SLAEBZ( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void SLAEBZ_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void slaebz( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void slaebz_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void SLAED0( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void SLAED0_( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void slaed0( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void slaed0_( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void SLAED1( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void SLAED1_( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void slaed1( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void slaed1_( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void SLAED2( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void SLAED2_( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void slaed2( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void slaed2_( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void SLAED3( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void SLAED3_( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void slaed3( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void slaed3_( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void SLAED4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void SLAED4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void slaed4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void slaed4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void SLAED5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void SLAED5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void slaed5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void slaed5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void SLAED6( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void SLAED6_( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void slaed6( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void slaed6_( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void SLAED7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void SLAED7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void slaed7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void slaed7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void SLAED8( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void SLAED8_( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void slaed8( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void slaed8_( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void SLAED9( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void SLAED9_( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void slaed9( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void slaed9_( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void SLAEDA( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void SLAEDA_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void slaeda( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void slaeda_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void SLAEIN( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void SLAEIN_( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void slaein( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void slaein_( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void SLAEV2( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void SLAEV2_( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void slaev2( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void slaev2_( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void SLAEXC( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void SLAEXC_( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void slaexc( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void slaexc_( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void SLAG2D( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void SLAG2D_( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void slag2d( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void slag2d_( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void SLAG2( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void SLAG2_( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void slag2( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void slag2_( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void SLAGS2( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void SLAGS2_( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void slags2( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void slags2_( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void SLAGTF( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void SLAGTF_( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void slagtf( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void slagtf_( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void SLAGTM( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void SLAGTM_( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void slagtm( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void slagtm_( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void SLAGTS( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void SLAGTS_( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void slagts( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void slagts_( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void SLAGV2( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void SLAGV2_( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void slagv2( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void slagv2_( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void SLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void SLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void slahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void slahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void SLAHR2( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAHR2_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahr2( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahr2_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAHRD( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAHRD_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahrd( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahrd_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAIC1( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); void SLAIC1_( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); void slaic1( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); void slaic1_( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); int SLAISNAN( const float* sin1, const float* sin2 ); int SLAISNAN_( const float* sin1, const float* sin2 ); int slaisnan( const float* sin1, const float* sin2 ); int slaisnan_( const float* sin1, const float* sin2 ); void SLALN2( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void SLALN2_( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void slaln2( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void slaln2_( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void SLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void SLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void slals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void slals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void SLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void SLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void slalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void slalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void SLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); void SLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); void slalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); void slalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); float SLAMCH( const char* cmach ); float SLAMCH_( const char* cmach ); float slamch( const char* cmach ); float slamch_( const char* cmach ); void SLAMC1( int* beta, int* t, int* rnd, int* ieee1 ); void SLAMC1_( int* beta, int* t, int* rnd, int* ieee1 ); void slamc1( int* beta, int* t, int* rnd, int* ieee1 ); void slamc1_( int* beta, int* t, int* rnd, int* ieee1 ); void SLAMC2( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); void SLAMC2_( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); void slamc2( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); void slamc2_( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); float SLAMC3( const float* a, const float* b ); float SLAMC3_( const float* a, const float* b ); float slamc3( const float* a, const float* b ); float slamc3_( const float* a, const float* b ); void SLAMC4( int* emin, const float* start, const int* base ); void SLAMC4_( int* emin, const float* start, const int* base ); void slamc4( int* emin, const float* start, const int* base ); void slamc4_( int* emin, const float* start, const int* base ); void SLAMC5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void SLAMC5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void slamc5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void slamc5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void SLAMRG( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); void SLAMRG_( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); void slamrg( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); void slamrg_( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); int SLANEG( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); int SLANEG_( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); int slaneg( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); int slaneg_( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); float SLANGB( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float SLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float slangb( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float slangb_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float SLANGE( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float SLANGE_( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float slange( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float slange_( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float SLANGT( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float SLANGT_( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float slangt( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float slangt_( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float SLANHS( const char* norm, const int* n, const float* a, const int* lda, float* work ); float SLANHS_( const char* norm, const int* n, const float* a, const int* lda, float* work ); float slanhs( const char* norm, const int* n, const float* a, const int* lda, float* work ); float slanhs_( const char* norm, const int* n, const float* a, const int* lda, float* work ); float SLANSB( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slansb( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slansb_( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANSF( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float SLANSF_( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float slansf( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float slansf_( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float SLANSP( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float SLANSP_( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float slansp( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float slansp_( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float SLANST( const char* norm, const int* n, const float* d, const float* e ); float SLANST_( const char* norm, const int* n, const float* d, const float* e ); float slanst( const char* norm, const int* n, const float* d, const float* e ); float slanst_( const char* norm, const int* n, const float* d, const float* e ); float SLANSY( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float SLANSY_( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float slansy( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float slansy_( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float SLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float SLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float slantp( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float slantp_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float SLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); float SLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); float slantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); float slantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); void SLANV2( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void SLANV2_( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void slanv2( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void slanv2_( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void SLAPLL( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void SLAPLL_( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void slapll( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void slapll_( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void SLAPMT( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void SLAPMT_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmt( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmt_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); float SLAPY2( const float* x, const float* y ); float SLAPY2_( const float* x, const float* y ); float slapy2( const float* x, const float* y ); float slapy2_( const float* x, const float* y ); float SLAPY3( const float* x, const float* y, const float* z ); float SLAPY3_( const float* x, const float* y, const float* z ); float slapy3( const float* x, const float* y, const float* z ); float slapy3_( const float* x, const float* y, const float* z ); void SLAQGB( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQGB_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqgb( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqgb_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQGE( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQGE_( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqge( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqge_( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQP2( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void SLAQP2_( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void slaqp2( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void slaqp2_( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void SLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void SLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void slaqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void slaqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void SLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR1( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void SLAQR1_( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void slaqr1( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void slaqr1_( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void SLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void SLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void slaqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void slaqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void SLAQSB( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSB_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void slaqsb( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void slaqsb_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSP( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSP_( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void slaqsp( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void slaqsp_( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSY( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSY_( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void slaqsy( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void slaqsy_( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void SLAQTR( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void SLAQTR_( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void slaqtr( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void slaqtr_( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void SLAR1V( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void SLAR1V_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void slar1v( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void slar1v_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void SLAR2V( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void SLAR2V_( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void slar2v( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void slar2v_( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void SLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARF( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARF_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarf( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarf_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARFG( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFG_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfg( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfg_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFGP( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFGP_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfgp( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfgp_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFP( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFP_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfp( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfp_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFT( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLARFT_( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarft( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarft_( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLARFX( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void SLARFX_( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void slarfx( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void slarfx_( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void SLARGV( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void SLARGV_( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void slargv( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void slargv_( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void SLARNV( const int* idist, int* iseed, const int* n, float* x ); void SLARNV_( const int* idist, int* iseed, const int* n, float* x ); void slarnv( const int* idist, int* iseed, const int* n, float* x ); void slarnv_( const int* idist, int* iseed, const int* n, float* x ); void SLARRA( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void SLARRA_( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void slarra( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void slarra_( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void SLARRB( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void SLARRB_( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void slarrb( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void slarrb_( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void SLARRC( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void SLARRC_( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void slarrc( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void slarrc_( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void SLARRD( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void SLARRD_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void slarrd( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void slarrd_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void SLARRE( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void SLARRE_( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void slarre( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void slarre_( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void SLARRF( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void SLARRF_( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void slarrf( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void slarrf_( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void SLARRJ( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void SLARRJ_( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void slarrj( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void slarrj_( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void SLARRK( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void SLARRK_( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void slarrk( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void slarrk_( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void SLARRR( const int* n, const float* d, float* e, int* info ); void SLARRR_( const int* n, const float* d, float* e, int* info ); void slarrr( const int* n, const float* d, float* e, int* info ); void slarrr_( const int* n, const float* d, float* e, int* info ); void SLARRV( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void SLARRV_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void slarrv( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void slarrv_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void SLARSCL2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLARSCL2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slarscl2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slarscl2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLARTG( const float* f, const float* g, float* cs, float* sn, float* r ); void SLARTG_( const float* f, const float* g, float* cs, float* sn, float* r ); void slartg( const float* f, const float* g, float* cs, float* sn, float* r ); void slartg_( const float* f, const float* g, float* cs, float* sn, float* r ); void SLARTV( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void SLARTV_( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void slartv( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void slartv_( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void SLARUV( int* iseed, const int* n, float* x ); void SLARUV_( int* iseed, const int* n, float* x ); void slaruv( int* iseed, const int* n, float* x ); void slaruv_( int* iseed, const int* n, float* x ); void SLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARZ( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARZ_( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarz( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarz_( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARZT( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLARZT_( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarzt( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarzt_( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLAS2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void SLAS2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void slas2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void slas2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void SLASCL( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void SLASCL_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void slascl( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void slascl_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void SLASCL2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLASCL2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slascl2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slascl2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLASD0( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void SLASD0_( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void slasd0( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void slasd0_( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void SLASD1( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void SLASD1_( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void slasd1( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void slasd1_( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void SLASD2( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void SLASD2_( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void slasd2( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void slasd2_( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void SLASD3( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void SLASD3_( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void slasd3( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void slasd3_( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void SLASD4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void SLASD4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void slasd4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void slasd4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void SLASD5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void SLASD5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void slasd5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void slasd5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void SLASD6( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void SLASD6_( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void slasd6( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void slasd6_( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void SLASD7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void SLASD7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void slasd7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void slasd7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void SLASD8( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void SLASD8_( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void slasd8( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void slasd8_( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void SLASDA( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void SLASDA_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void slasda( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void slasda_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void SLASDQ( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void SLASDQ_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void slasdq( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void slasdq_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void SLASDT( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void SLASDT_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void slasdt( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void slasdt_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void SLASET( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void SLASET_( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void slaset( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void slaset_( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void SLASQ1( const int* n, float* d, float* e, float* work, int* info ); void SLASQ1_( const int* n, float* d, float* e, float* work, int* info ); void slasq1( const int* n, float* d, float* e, float* work, int* info ); void slasq1_( const int* n, float* d, float* e, float* work, int* info ); void SLASQ2( const int* n, float* z, int* info ); void SLASQ2_( const int* n, float* z, int* info ); void slasq2( const int* n, float* z, int* info ); void slasq2_( const int* n, float* z, int* info ); void SLASQ3( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void SLASQ3_( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void slasq3( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void slasq3_( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void SLASQ4( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void SLASQ4_( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void slasq4( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void slasq4_( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void SLASQ5( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void SLASQ5_( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void slasq5( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void slasq5_( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void SLASQ6( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void SLASQ6_( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void slasq6( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void slasq6_( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void SLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void SLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void slasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void slasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void SLASRT( const char* id, const int* n, float* d, int* info ); void SLASRT_( const char* id, const int* n, float* d, int* info ); void slasrt( const char* id, const int* n, float* d, int* info ); void slasrt_( const char* id, const int* n, float* d, int* info ); void SLASSQ( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void SLASSQ_( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void slassq( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void slassq_( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void SLASV2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void SLASV2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void slasv2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void slasv2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void SLASWP( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void SLASWP_( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void slaswp( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void slaswp_( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void SLASY2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void SLASY2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void slasy2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void slasy2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void SLASYF( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SLASYF_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void SLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void slatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void slatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void SLATDF( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void SLATDF_( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void slatdf( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void slatdf_( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void SLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void SLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void slatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void slatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void SLATRD( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void SLATRD_( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void slatrd( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void slatrd_( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void SLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void SLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void slatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void slatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void SLATRZ( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void SLATRZ_( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void slatrz( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void slatrz_( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void SLATZM( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void SLATZM_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void slatzm( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void slatzm_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void SLAUU2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SLAUU2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauu2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauu2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SLAUUM( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SLAUUM_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauum( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauum_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SOPGTR( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void SOPGTR_( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void sopgtr( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void sopgtr_( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void SOPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void SOPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void sopmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void sopmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORG2L( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORG2L_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2l( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2l_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORG2R( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORG2R_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2r( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2r_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGBR( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGBR_( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgbr( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgbr_( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGHR( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGHR_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorghr( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorghr_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGL2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGL2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgl2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgl2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGLQ( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGLQ_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorglq( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorglq_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQL( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQL_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgql( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgql_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQR( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQR_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgqr( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgqr_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGR2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGR2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgr2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgr2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGRQ( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGRQ_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgrq( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgrq_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGTR( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGTR_( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgtr( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgtr_( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormql( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SPBCON( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPBCON_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spbcon( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spbcon_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPBEQU( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void SPBEQU_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void spbequ( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void spbequ_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void SPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBSTF( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBSTF_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbstf( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbstf_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBTF2( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTF2_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtf2( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtf2_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTRF( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTRF_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtrf( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtrf_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPFTRF( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRF_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftrf( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftrf_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRI( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRI_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftri( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftri_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void SPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void spftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void spftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void SPOCON( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPOCON_( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spocon( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spocon_( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPOEQUB( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPOEQUB_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequb( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequb_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPOEQU( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPOEQU_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequ( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequ_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPORFS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPORFS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sporfs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sporfs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPOSV( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void SPOSV_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void sposv( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void sposv_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void SPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPOTF2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTF2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotf2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotf2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRF( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRF_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRI( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRI_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotri( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotri_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void SPOTRS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void spotrs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void spotrs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void SPPCON( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPPCON_( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sppcon( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sppcon_( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPPEQU( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void SPPEQU_( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void sppequ( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void sppequ_( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void SPPRFS( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPRFS_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spprfs( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spprfs_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPSV( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void SPPSV_( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void sppsv( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void sppsv_( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void SPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPTRF( const char* uplo, const int* n, float* ap, int* info ); void SPPTRF_( const char* uplo, const int* n, float* ap, int* info ); void spptrf( const char* uplo, const int* n, float* ap, int* info ); void spptrf_( const char* uplo, const int* n, float* ap, int* info ); void SPPTRI( const char* uplo, const int* n, float* ap, int* info ); void SPPTRI_( const char* uplo, const int* n, float* ap, int* info ); void spptri( const char* uplo, const int* n, float* ap, int* info ); void spptri_( const char* uplo, const int* n, float* ap, int* info ); void SPPTRS( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void SPPTRS_( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void spptrs( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void spptrs_( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void SPSTF2( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPSTF2_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstf2( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstf2_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPSTRF( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPSTRF_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstrf( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstrf_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPTCON( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void SPTCON_( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void sptcon( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void sptcon_( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void SPTEQR( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SPTEQR_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void spteqr( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void spteqr_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SPTRFS( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void SPTRFS_( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void sptrfs( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void sptrfs_( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void SPTSV( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void SPTSV_( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void sptsv( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void sptsv_( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void SPTSVX( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void SPTSVX_( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void sptsvx( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void sptsvx_( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void SPTTRF( const int* n, float* d, float* e, int* info ); void SPTTRF_( const int* n, float* d, float* e, int* info ); void spttrf( const int* n, float* d, float* e, int* info ); void spttrf_( const int* n, float* d, float* e, int* info ); void SPTTRS( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void SPTTRS_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void spttrs( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void spttrs_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void SPTTS2( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void SPTTS2_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void sptts2( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void sptts2_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void SRSCL( const int* n, const float* sa, float* sx, const int* incx ); void SRSCL_( const int* n, const float* sa, float* sx, const int* incx ); void srscl( const int* n, const float* sa, float* sx, const int* incx ); void srscl_( const int* n, const float* sa, float* sx, const int* incx ); void SSBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEV( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void SSBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void ssbev( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void ssbev_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void SSBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void SSBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void ssbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void ssbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void SSBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void SSBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void ssbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void ssbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void SSBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBTRD( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void SSBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void ssbtrd( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void ssbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void SSFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void SSFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void ssfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void ssfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void SSPCON( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSPCON_( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sspcon( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sspcon_( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSPEVD( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPEVD_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspevd( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspevd_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPEV( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void SSPEV_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void sspev( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void sspev_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void SSPEVX( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspevx( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspevx_( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPGST( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void SSPGST_( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void sspgst( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void sspgst_( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void SSPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspgvd( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPGV( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void SSPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void sspgv( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void sspgv_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void SSPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPRFS( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPRFS_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssprfs( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssprfs_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPSV( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void SSPSV_( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void sspsv( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void sspsv_( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void SSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPTRD( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void SSPTRD_( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void ssptrd( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void ssptrd_( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void SSPTRF( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void SSPTRF_( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void ssptrf( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void ssptrf_( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void SSPTRI( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void SSPTRI_( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void ssptri( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void ssptri_( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void SSPTRS( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void SSPTRS_( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void ssptrs( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void ssptrs_( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void SSTEBZ( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void SSTEBZ_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void sstebz( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void sstebz_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void SSTEDC( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEDC_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstedc( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstedc_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEGR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEGR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstegr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstegr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEIN( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSTEIN_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstein( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstein_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSTEMR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEMR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstemr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstemr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEQR( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTEQR_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void ssteqr( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void ssteqr_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTERF( const int* n, float* d, float* e, int* info ); void SSTERF_( const int* n, float* d, float* e, int* info ); void ssterf( const int* n, float* d, float* e, int* info ); void ssterf_( const int* n, float* d, float* e, int* info ); void SSTEVD( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEVD_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevd( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevd_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEV( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTEV_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void sstev( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void sstev_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTEVR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEVR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEVX( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSTEVX_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstevx( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstevx_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSYCON( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCON_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYEQUB( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void SSYEQUB_( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void ssyequb( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void ssyequb_( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void SSYEVD( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVD_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEV( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEV_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEVR( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVR_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVX( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYEVX_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYGS2( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGS2_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygs2( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygs2_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGST( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGST_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygst( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygst_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGVD( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssygvd( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssygvd_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYGV( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYGV_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssygvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssygvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYRFS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSYRFS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssyrfs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssyrfs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYSV( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void SSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void ssysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void ssysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void SSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYTD2( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void SSYTD2_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void ssytd2( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void ssytd2_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void SSYTF2( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTF2_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTRD( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void SSYTRD_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void ssytrd( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void ssytrd_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void SSYTRF( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRI_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SSYTRS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void STBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void STBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void stbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void stbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void STBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void STBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void stbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void stbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void STFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void STFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void stfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void stfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void STFTRI( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void STFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void stftri( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void stftri_( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void STFTTP( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void STFTTP_( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void stfttp( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void stfttp_( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void STFTTR( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void STFTTR_( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void stfttr( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void stfttr_( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void STGEVC( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STGEVC_( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void stgevc( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void stgevc_( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STGEX2( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void STGEX2_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void stgex2( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void stgex2_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void STGEXC( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void STGEXC_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void stgexc( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void stgexc_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void STGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void stgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void stgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void STGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void stgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void stgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void STGSNA( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void STGSNA_( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void stgsna( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void stgsna_( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void STGSY2( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void STGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void stgsy2( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void stgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void STGSYL( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void STGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void stgsyl( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void stgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void STPCON( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void STPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void stpcon( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void stpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void STPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STPTRI( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void STPTRI_( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void stptri( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void stptri_( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void STPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void STPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void stptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void stptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void STPTTF( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void STPTTF_( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void stpttf( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void stpttf_( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void STPTTR( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void STPTTR_( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void stpttr( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void stpttr_( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void STRCON( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void STRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void strcon( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void strcon_( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void STREVC( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STREVC_( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void strevc( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void strevc_( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STREXC( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void STREXC_( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void strexc( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void strexc_( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void STRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void strrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void strrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STRSEN( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STRSEN_( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void strsen( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void strsen_( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STRSNA( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void STRSNA_( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void strsna( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void strsna_( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void STRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void STRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void strsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void strsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void STRTI2( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTI2_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strti2( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strti2_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTRI( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTRI_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strtri( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strtri_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void STRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void strtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void strtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void STRTTF( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void STRTTF_( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void strttf( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void strttf_( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void STRTTP( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void STRTTP_( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void strttp( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void strttp_( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void STZRQF( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void STZRQF_( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void stzrqf( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void stzrqf_( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void STZRZF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void STZRZF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void stzrzf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void stzrzf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void XERBLA_ARRAY( const char* srname_array, const int* srname_len, const int* info ); void XERBLA_ARRAY_( const char* srname_array, const int* srname_len, const int* info ); void xerbla_array( const char* srname_array, const int* srname_len, const int* info ); void xerbla_array_( const char* srname_array, const int* srname_len, const int* info ); void ZBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void ZBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void zbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void zbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void ZCGESV( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZCGESV_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcgesv( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcgesv_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZCPOSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZCPOSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcposv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcposv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZDRSCL( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void ZDRSCL_( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void zdrscl( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void zdrscl_( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void ZGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void ZGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void zgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void zgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void ZGBCON( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgbcon( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequb( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequb_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBEQU( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequ( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequ_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBTF2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTF2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtf2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtf2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTRF( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTRF_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtrf( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtrf_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGEBAL( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void ZGEBAL_( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void zgebal( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void zgebal_( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void ZGEBD2( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void ZGEBD2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void zgebd2( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void zgebd2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void ZGEBRD( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void ZGEBRD_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void zgebrd( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void zgebrd_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void ZGECON( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGECON_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgecon( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgecon_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGEEQUB( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEEQUB_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequb( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequb_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEEQU( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEEQU_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequ( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequ_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEES( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEES_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgees( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgees_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEESX( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEESX_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgeesx( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgeesx_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGS( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGS_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegs( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegs_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegv( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegv_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEHD2( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEHD2_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgehd2( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgehd2_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEHRD( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEHRD_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgehrd( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgehrd_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGELQ2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGELQ2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgelq2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgelq2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGELQF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGELQF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgelqf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgelqf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGELSD( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGELSD_( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgelsd( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgelsd_( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGELS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZGELS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgels( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgels_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZGELSS( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGELSS_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelss( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelss_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGELSX( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void ZGELSX_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void zgelsx( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void zgelsx_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void ZGELSY( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGELSY_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelsy( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelsy_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEQL2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQL2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeql2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeql2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQLF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQLF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqlf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqlf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQP3( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEQP3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeqp3( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeqp3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEQPF( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void ZGEQPF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void zgeqpf( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void zgeqpf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void ZGEQR2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQR2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQR2P( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQR2P_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2p( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2p_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQRF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQRF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQRFP( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQRFP_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrfp( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrfp_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGERFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGERFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgerfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgerfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGERQ2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGERQ2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgerq2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgerq2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGERQF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGERQF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgerqf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgerqf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGESC2( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void ZGESC2_( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void zgesc2( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void zgesc2_( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void ZGESDD( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGESDD_( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgesdd( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgesdd_( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGESV( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGESV_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgesv( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgesv_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGETC2( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void ZGETC2_( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void zgetc2( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void zgetc2_( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void ZGETF2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETF2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetf2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetf2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETRF( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETRF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void MKL_ZGETRFNPI( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void MKL_ZGETRFNPI_( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnpi( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnpi_( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void ZGETRI( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZGETRI_( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zgetri( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zgetri_( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZGETRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGETRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgetrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgetrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGGBAL( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void ZGGBAL_( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void zggbal( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void zggbal_( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void ZGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void ZGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void zggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void zggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void ZGGEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGGEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void ZGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void zggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void zggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void ZGGGLM( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void ZGGGLM_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void zggglm( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void zggglm_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void ZGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void ZGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void zgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void zgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void ZGGLSE( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void ZGGLSE_( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void zgglse( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void zgglse_( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void ZGGQRF( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGQRF_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggqrf( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggqrf_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGRQF( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGRQF_( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggrqf( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggrqf_( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGTCON( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZGTCON_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zgtcon( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zgtcon_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZGTRFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTRFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtrfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtrfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTSV( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZGTSV_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zgtsv( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zgtsv_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTTRF( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void ZGTTRF_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void zgttrf( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void zgttrf_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void ZGTTRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGTTRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgttrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgttrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGTTS2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void ZGTTS2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void zgtts2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void zgtts2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void ZHBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEV( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbev( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbev_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void ZHBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void zhbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void zhbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void ZHBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBTRD( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZHBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zhbtrd( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zhbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZHECON( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHECON_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHEEQUB( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZHEEQUB_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zheequb( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zheequb_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZHEEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEV( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEVR( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVR_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEGS2( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGS2_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegs2( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegs2_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGST( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGST_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegst( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegst_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhegvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhegvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhegvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhegvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHERFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHERFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zherfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zherfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHERFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHERFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zherfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zherfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHESV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHESVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhesvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhesvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHESVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHESVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zhesvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zhesvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHETD2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHETD2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void zhetd2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void zhetd2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHETF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETRD( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRI_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHETRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void ZHFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void zhfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void zhfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void ZHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHPCON( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHPCON_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhpcon( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhpcon_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHPEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpevd( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPEV( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpev( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpev_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPGST( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void ZHPGST_( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void zhpgst( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void zhpgst_( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void ZHPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpgvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpgv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpgv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhpsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhpsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhpsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhpsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPTRD( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHPTRD_( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void zhptrd( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void zhptrd_( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHPTRF( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZHPTRF_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zhptrf( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zhptrf_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZHPTRI( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZHPTRI_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zhptri( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zhptri_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZHPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHSEIN( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void ZHSEIN_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void zhsein( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void zhsein_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void ZHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zhseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zhseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLABRD( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void ZLABRD_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void zlabrd( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void zlabrd_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void ZLACGV( const int* n, MKL_Complex16* x, const int* incx ); void ZLACGV_( const int* n, MKL_Complex16* x, const int* incx ); void zlacgv( const int* n, MKL_Complex16* x, const int* incx ); void zlacgv_( const int* n, MKL_Complex16* x, const int* incx ); void ZLACN2( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void ZLACN2_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void zlacn2( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void zlacn2_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void ZLACON( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void ZLACON_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void zlacon( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void zlacon_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void ZLACP2( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACP2_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacp2( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacp2_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACPY( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACPY_( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacpy( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacpy_( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACRM( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLACRM_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlacrm( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlacrm_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLACRT( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void ZLACRT_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void zlacrt( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void zlacrt_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void ZLADIV( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void ZLADIV_( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void zladiv( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void zladiv_( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void ZLAED0( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void ZLAED0_( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void zlaed0( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void zlaed0_( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void ZLAED7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZLAED7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlaed7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlaed7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZLAED8( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void ZLAED8_( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void zlaed8( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void zlaed8_( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void ZLAEIN( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void ZLAEIN_( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void zlaein( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void zlaein_( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void ZLAESY( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void ZLAESY_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void zlaesy( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void zlaesy_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void ZLAEV2( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void ZLAEV2_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void zlaev2( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void zlaev2_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void ZLAG2C( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLAG2C_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlag2c( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlag2c_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLAGS2( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void ZLAGS2_( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void zlags2( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void zlags2_( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void ZLAGTM( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void ZLAGTM_( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void zlagtm( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void zlagtm_( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void ZLAHEF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHEF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void ZLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void zlahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void zlahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void ZLAHR2( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAHR2_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahr2( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahr2_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAHRD( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAHRD_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahrd( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahrd_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAIC1( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void ZLAIC1_( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void zlaic1( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void zlaic1_( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void ZLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void ZLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void zlals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void zlals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void ZLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void ZLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void zlalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void zlalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void ZLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); double ZLANGB( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double zlangb( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double zlangb_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANGE( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANGE_( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlange( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlange_( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANGT( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double ZLANGT_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double zlangt( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double zlangt_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double ZLANHB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANHB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlanhb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlanhb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANHE( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHE_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhe( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhe_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHF( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double ZLANHF_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double zlanhf( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double zlanhf_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double ZLANHP( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANHP_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlanhp( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlanhp_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANHS( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHS_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhs( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhs_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHT( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double ZLANHT_( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double zlanht( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double zlanht_( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double ZLANSB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlansb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlansb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANSP( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANSP_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlansp( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlansp_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANSY( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANSY_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlansy( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlansy_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double ZLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double zlantp( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double zlantp_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double ZLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); void ZLAPLL( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void ZLAPLL_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void zlapll( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void zlapll_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void ZLAPMT( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void ZLAPMT_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmt( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmt_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void ZLAQGB( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQGB_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqgb( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqgb_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQGE( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQGE_( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqge( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqge_( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQHB( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void ZLAQHB_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void zlaqhb( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void zlaqhb_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void ZLAQHE( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQHE_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhe( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhe_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQHP( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQHP_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhp( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhp_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQP2( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void ZLAQP2_( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void zlaqp2( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void zlaqp2_( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void ZLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void ZLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void zlaqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void zlaqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void ZLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR1( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void ZLAQR1_( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void zlaqr1( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void zlaqr1_( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void ZLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void ZLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void zlaqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void zlaqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void ZLAQSB( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSB_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsb( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsb_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSP( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSP_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsp( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsp_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSY( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSY_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsy( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsy_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAR1V( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void ZLAR1V_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void zlar1v( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void zlar1v_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void ZLAR2V( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void ZLAR2V_( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void zlar2v( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void zlar2v_( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void ZLARCM( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLARCM_( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlarcm( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlarcm_( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARF( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARF_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarf( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarf_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARFG( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFG_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfg( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfg_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFGP( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFGP_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfgp( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfgp_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFP( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFP_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfp( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfp_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFT( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLARFT_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarft( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarft_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLARFX( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARFX_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfx( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfx_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARGV( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void ZLARGV_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void zlargv( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void zlargv_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void ZLARNV( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void ZLARNV_( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void zlarnv( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void zlarnv_( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void ZLARRV( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void ZLARRV_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void zlarrv( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void zlarrv_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void ZLARSCL2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLARSCL2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlarscl2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlarscl2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLARTG( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void ZLARTG_( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void zlartg( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void zlartg_( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void ZLARTV( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void ZLARTV_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void zlartv( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void zlartv_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void ZLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARZ( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARZ_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarz( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarz_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARZT( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLARZT_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarzt( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarzt_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLASCL( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLASCL_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlascl( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlascl_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLASCL2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLASCL2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlascl2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlascl2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLASET( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void ZLASET_( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void zlaset( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void zlaset_( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void ZLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void ZLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void zlasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void zlasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void ZLASSQ( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void ZLASSQ_( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void zlassq( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void zlassq_( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void ZLASWP( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void ZLASWP_( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void zlaswp( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void zlaswp_( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void ZLASYF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAT2C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLAT2C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlat2c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlat2c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATDF( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void ZLATDF_( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void zlatdf( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void zlatdf_( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void ZLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATRD( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void ZLATRD_( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void zlatrd( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void zlatrd_( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void ZLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATRZ( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void ZLATRZ_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void zlatrz( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void zlatrz_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void ZLATZM( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void ZLATZM_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void zlatzm( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void zlatzm_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void ZLAUU2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLAUU2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauu2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauu2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLAUUM( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLAUUM_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauum( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauum_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPBCON( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPBCON_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpbcon( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpbcon_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPBEQU( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void ZPBEQU_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void zpbequ( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void zpbequ_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void ZPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBSTF( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBSTF_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbstf( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbstf_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBTF2( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTF2_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtf2( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtf2_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTRF( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTRF_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtrf( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtrf_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPFTRF( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRF_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftrf( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftrf_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRI( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRI_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftri( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftri_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void ZPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void zpftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void zpftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void ZPOCON( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPOCON_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpocon( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpocon_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPOEQUB( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPOEQUB_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequb( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequb_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPOEQU( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPOEQU_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequ( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequ_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPORFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPORFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zporfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zporfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPOSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPOSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zposv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zposv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPOTF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRI( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRI_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotri( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotri_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPOTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zpotrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zpotrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPPCON( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPPCON_( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zppcon( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zppcon_( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPPEQU( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void ZPPEQU_( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void zppequ( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void zppequ_( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void ZPPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zppsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zppsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPTRF( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRF_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptrf( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptrf_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRI( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRI_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptri( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptri_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zpptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zpptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPSTF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPSTF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPSTRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPSTRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPTCON( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void ZPTCON_( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void zptcon( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void zptcon_( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void ZPTEQR( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZPTEQR_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zpteqr( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zpteqr_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZPTRFS( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTRFS_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptrfs( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptrfs_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTSV( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTSV_( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zptsv( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zptsv_( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTSVX( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTSVX_( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptsvx( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptsvx_( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTTRF( const int* n, double* d, MKL_Complex16* e, int* info ); void ZPTTRF_( const int* n, double* d, MKL_Complex16* e, int* info ); void zpttrf( const int* n, double* d, MKL_Complex16* e, int* info ); void zpttrf_( const int* n, double* d, MKL_Complex16* e, int* info ); void ZPTTRS( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTTRS_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zpttrs( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zpttrs_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTTS2( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void ZPTTS2_( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void zptts2( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void zptts2_( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void ZROT( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void ZROT_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void zrot( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void zrot_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void ZSPCON( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSPCON_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zspcon( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zspcon_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSPMV( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSPMV_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zspmv( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zspmv_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSPR( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void ZSPR_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void zspr( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void zspr_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void ZSPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zspsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zspsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPTRF( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZSPTRF_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zsptrf( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zsptrf_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZSPTRI( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZSPTRI_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zsptri( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zsptri_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZSPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSTEDC( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZSTEDC_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zstedc( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zstedc_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZSTEGR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEGR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstegr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstegr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEIN( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void ZSTEIN_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void zstein( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void zstein_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void ZSTEMR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEMR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstemr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstemr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEQR( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZSTEQR_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zsteqr( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zsteqr_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZSYCON( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCON_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYEQUB( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZSYEQUB_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zsyequb( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zsyequb_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZSYMV( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSYMV_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zsymv( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zsymv_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSYR( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void ZSYR_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void zsyr( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void zsyr_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void ZSYRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSYRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsyrfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsyrfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zsysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zsysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYTF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRI_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZTBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZTBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ztbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ztbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZTFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ZTFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ztfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ztfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ZTFTRI( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ZTFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ztftri( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ztftri_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ZTFTTP( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ZTFTTP_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ztfttp( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ztfttp_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ZTFTTR( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ZTFTTR_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ztfttr( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ztfttr_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ZTGEVC( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTGEVC_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztgevc( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztgevc_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTGEX2( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ZTGEX2_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ztgex2( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ztgex2_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ZTGEXC( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ZTGEXC_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ztgexc( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ztgexc_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ZTGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZTGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ztgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ztgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZTGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ZTGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ztgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ztgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ZTGSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTGSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTGSY2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ZTGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ztgsy2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ztgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ZTGSYL( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsyl( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTPCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztpcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTPTRI( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ZTPTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ztptri( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ztptri_( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ZTPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZTPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ztptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ztptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZTPTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ZTPTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ztpttf( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ztpttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ZTPTTR( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ZTPTTR_( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ztpttr( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ztpttr_( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ZTRCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztrcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztrcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTREVC( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTREVC_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztrevc( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztrevc_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTREXC( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ZTREXC_( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ztrexc( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ztrexc_( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ZTRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztrrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztrrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTRSEN( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ZTRSEN_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ztrsen( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ztrsen_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ZTRSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ZTRSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ztrsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ztrsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ZTRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ZTRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ztrsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ztrsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ZTRTI2( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTI2_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrti2( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrti2_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTRI( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrtri( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrtri_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZTRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ztrtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ztrtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZTRTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ZTRTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ztrttf( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ztrttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ZTRTTP( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ZTRTTP_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ztrttp( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ztrttp_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ZTZRQF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ZTZRQF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ztzrqf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ztzrqf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ZTZRZF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZTZRZF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ztzrzf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ztzrzf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNG2L( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNG2L_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2l( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2l_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNG2R( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNG2R_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2r( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2r_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGBR( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGBR_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungbr( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungbr_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGHR( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGHR_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunghr( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunghr_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGL2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGL2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungl2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungl2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGLQ( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGLQ_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunglq( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunglq_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQL( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQL_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungql( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungql_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQR( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQR_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungqr( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungqr_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGR2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGR2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungr2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungr2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGRQ( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGRQ_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungrq( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungrq_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGTR( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGTR_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungtr( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungtr_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmql( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUPGTR( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZUPGTR_( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zupgtr( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zupgtr_( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZUPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zupmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zupmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void CGEQRT2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGEQRT2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CHESWAPR( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void CHESWAPR_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void cheswapr( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void cheswapr_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void CHETRI2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI2X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CHETRI2X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri2x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri2x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_GBRCOND_C( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GBRCOND_C_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_c( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_c_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GBRCOND_X( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_GBRCOND_X_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_x( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_x_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); float CLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); float cla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); float cla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); void CLA_GEAMV( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_GEAMV_( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_geamv( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_geamv_( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_GERCOND_C( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GERCOND_C_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_c( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_c_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GERCOND_X( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_GERCOND_X_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_x( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_x_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_GERPVGRW( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); float CLA_GERPVGRW_( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); float cla_gerpvgrw( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); float cla_gerpvgrw_( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); void CLA_HEAMV( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_HEAMV_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_heamv( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_heamv_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_HERCOND_C( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_HERCOND_C_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_c( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_c_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_HERCOND_X( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_HERCOND_X_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_x( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_x_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_HERFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_HERFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_herfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_herfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_HERPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float CLA_HERPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_herpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_herpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); void CLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); void CLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); void cla_lin_berr( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); void cla_lin_berr_( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); float CLA_PORCOND_C( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_PORCOND_C_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_c( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_c_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_PORCOND_X( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_PORCOND_X_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_x( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_x_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_PORPVGRW( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); float CLA_PORPVGRW_( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); float cla_porpvgrw( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); float cla_porpvgrw_( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); void CLA_SYAMV( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_SYAMV_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_syamv( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_syamv_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_SYRCOND_C( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_SYRCOND_C_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_c( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_c_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_SYRCOND_X( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_SYRCOND_X_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_x( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_x_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float CLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_syrpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_syrpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); void CLA_WWADDW( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void CLA_WWADDW_( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void cla_wwaddw( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void cla_wwaddw_( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void CTPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void CTPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void ctprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void ctprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void DGEQRT2( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGEQRT2_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt2( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt2_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void DLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); double DLA_GBRCOND( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_GBRCOND_( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gbrcond( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gbrcond_( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); double DLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); double dla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); double dla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); void DLA_GEAMV( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void DLA_GEAMV_( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_geamv( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_geamv_( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); double DLA_GERCOND( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_GERCOND_( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gercond( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gercond_( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_GERPVGRW( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); double DLA_GERPVGRW_( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); double dla_gerpvgrw( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); double dla_gerpvgrw_( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); void DLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); void DLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); void dla_lin_berr( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); void dla_lin_berr_( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); double DLA_PORCOND( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_PORCOND_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_porcond( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_porcond_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_PORPVGRW( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); double DLA_PORPVGRW_( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); double dla_porpvgrw( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); double dla_porpvgrw_( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); void DLA_SYAMV( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void DLA_SYAMV_( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_syamv( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_syamv_( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); double DLA_SYRCOND( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_SYRCOND_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_syrcond( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_syrcond_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); double DLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); double dla_syrpvgrw( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); double dla_syrpvgrw_( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); void DLA_WWADDW( const int* n, double* x, double* y, const double* w ); void DLA_WWADDW_( const int* n, double* x, double* y, const double* w ); void dla_wwaddw( const int* n, double* x, double* y, const double* w ); void dla_wwaddw_( const int* n, double* x, double* y, const double* w ); void DTPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void DTPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void dtprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void dtprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void SGEQRT2( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGEQRT2_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt2( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt2_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void SLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); float SLA_GBRCOND( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_GBRCOND_( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gbrcond( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gbrcond_( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); float SLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); float sla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); float sla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); void SLA_GEAMV( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void SLA_GEAMV_( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_geamv( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_geamv_( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); float SLA_GERCOND( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_GERCOND_( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gercond( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gercond_( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_GERPVGRW( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); float SLA_GERPVGRW_( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); float sla_gerpvgrw( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); float sla_gerpvgrw_( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); void SLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); void SLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); void sla_lin_berr( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); void sla_lin_berr_( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); float SLA_PORCOND( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_PORCOND_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_porcond( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_porcond_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_PORPVGRW( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); float SLA_PORPVGRW_( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); float sla_porpvgrw( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); float sla_porpvgrw_( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); void SLA_SYAMV( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void SLA_SYAMV_( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_syamv( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_syamv_( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); float SLA_SYRCOND( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_SYRCOND_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_syrcond( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_syrcond_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); float SLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); float sla_syrpvgrw( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); float sla_syrpvgrw_( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); void SLA_WWADDW( const int* n, float* x, float* y, const float* w ); void SLA_WWADDW_( const int* n, float* x, float* y, const float* w ); void sla_wwaddw( const int* n, float* x, float* y, const float* w ); void sla_wwaddw_( const int* n, float* x, float* y, const float* w ); void STPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void STPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void stprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void stprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void ZGEQRT2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGEQRT2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZHESWAPR( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void ZHESWAPR_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zheswapr( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zheswapr_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void ZHETRI2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI2X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZHETRI2X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri2x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri2x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_GBRCOND_C( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GBRCOND_C_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_c( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_c_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GBRCOND_X( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GBRCOND_X_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_x( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_x_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); double ZLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); double zla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); double zla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); void ZLA_GEAMV( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_GEAMV_( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_geamv( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_geamv_( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_GERCOND_C( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GERCOND_C_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_c( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_c_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GERCOND_X( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GERCOND_X_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_x( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_x_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_GERPVGRW( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); double ZLA_GERPVGRW_( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); double zla_gerpvgrw( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); double zla_gerpvgrw_( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); void ZLA_HEAMV( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_HEAMV_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_heamv( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_heamv_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_HERCOND_C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_HERCOND_C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_HERCOND_X( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_HERCOND_X_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_x( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_x_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_HERFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_HERFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_herfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_herfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_HERPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double ZLA_HERPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_herpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_herpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); void ZLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); void ZLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); void zla_lin_berr( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); void zla_lin_berr_( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); double ZLA_PORCOND_C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_PORCOND_C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_PORCOND_X( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_PORCOND_X_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_x( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_x_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_PORPVGRW( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); double ZLA_PORPVGRW_( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); double zla_porpvgrw( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); double zla_porpvgrw_( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); void ZLA_SYAMV( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_SYAMV_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_syamv( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_syamv_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_SYRCOND_C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_SYRCOND_C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_SYRCOND_X( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_SYRCOND_X_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_x( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_x_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double ZLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_syrpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_syrpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); void ZLA_WWADDW( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void ZLA_WWADDW_( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void zla_wwaddw( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void zla_wwaddw_( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void ZTPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void ZTPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void ztprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void ztprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void CHERDB( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CHERDB_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cherdb( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cherdb_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void DSYRDB( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DSYRDB_( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsyrdb( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsyrdb_( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void SSYRDB( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SSYRDB_( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssyrdb( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssyrdb_( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ZHERDB( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZHERDB_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zherdb( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zherdb_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void CDTSVB( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CDTSVB_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdtsvb( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdtsvb_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CDTTRFB( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void CDTTRFB_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void cdttrfb( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void cdttrfb_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void CDTTRSB( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CDTTRSB_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdttrsb( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdttrsb_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void DDTSVB( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void DDTSVB_( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void ddtsvb( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void ddtsvb_( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void DDTTRFB( const int* n, double* dl, double* d, const double* du, int* info ); void DDTTRFB_( const int* n, double* dl, double* d, const double* du, int* info ); void ddttrfb( const int* n, double* dl, double* d, const double* du, int* info ); void ddttrfb_( const int* n, double* dl, double* d, const double* du, int* info ); void DDTTRSB( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void DDTTRSB_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void ddttrsb( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void ddttrsb_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void SDTSVB( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void SDTSVB_( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void sdtsvb( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void sdtsvb_( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void SDTTRFB( const int* n, float* dl, float* d, const float* du, int* info ); void SDTTRFB_( const int* n, float* dl, float* d, const float* du, int* info ); void sdttrfb( const int* n, float* dl, float* d, const float* du, int* info ); void sdttrfb_( const int* n, float* dl, float* d, const float* du, int* info ); void SDTTRSB( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void SDTTRSB_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void sdttrsb( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void sdttrsb_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void ZDTSVB( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZDTSVB_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdtsvb( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdtsvb_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZDTTRFB( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void ZDTTRFB_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void zdttrfb( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void zdttrfb_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void ZDTTRSB( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZDTTRSB_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdttrsb( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdttrsb_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void MKL_CTPPACK( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void MKL_CTPPACK_( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void mkl_ctppack( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void mkl_ctppack_( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void MKL_DTPPACK( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void MKL_DTPPACK_( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void mkl_dtppack( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void mkl_dtppack_( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void MKL_STPPACK( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void MKL_STPPACK_( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void mkl_stppack( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void mkl_stppack_( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void MKL_ZTPPACK( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void MKL_ZTPPACK_( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void mkl_ztppack( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void mkl_ztppack_( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void MKL_CTPUNPACK( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void MKL_CTPUNPACK_( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void mkl_ctpunpack( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void mkl_ctpunpack_( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void MKL_DTPUNPACK( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void MKL_DTPUNPACK_( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void mkl_dtpunpack( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void mkl_dtpunpack_( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void MKL_STPUNPACK( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void MKL_STPUNPACK_( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void mkl_stpunpack( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void mkl_stpunpack_( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void MKL_ZTPUNPACK( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void MKL_ZTPUNPACK_( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void mkl_ztpunpack( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void mkl_ztpunpack_( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void DLATM1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void DLATM1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void dlatm1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void dlatm1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void SLATM1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void SLATM1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void slatm1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void slatm1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void CLATM1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void CLATM1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void clatm1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void clatm1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void ZLATM1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); void ZLATM1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); void zlatm1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); void zlatm1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); double DLATM2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); double DLATM2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); double dlatm2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); double dlatm2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); float SLATM2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); float SLATM2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); float slatm2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); float slatm2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); void CLATM2( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void CLATM2_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void clatm2( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void clatm2_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void ZLATM2( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); void ZLATM2_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); void zlatm2( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); void zlatm2_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); double DLATM3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); double DLATM3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); double dlatm3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); double dlatm3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); float SLATM3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); float SLATM3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); float slatm3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); float slatm3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); void CLATM3( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void CLATM3_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void clatm3( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void clatm3_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void ZLATM3( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void ZLATM3_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void zlatm3( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void zlatm3_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void DLATM5( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void DLATM5_( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void dlatm5( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void dlatm5_( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void SLATM5( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void SLATM5_( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void slatm5( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void slatm5_( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void CLATM5( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void CLATM5_( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void clatm5( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void clatm5_( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void ZLATM5( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void ZLATM5_( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void zlatm5( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void zlatm5_( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void DLATM6( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void DLATM6_( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void dlatm6( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void dlatm6_( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void SLATM6( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void SLATM6_( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void slatm6( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void slatm6_( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void CLATM6( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void CLATM6_( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void clatm6( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void clatm6_( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void ZLATM6( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void ZLATM6_( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void zlatm6( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void zlatm6_( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void DLATME( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void DLATME_( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void dlatme( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void dlatme_( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void SLATME( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void SLATME_( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void slatme( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void slatme_( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void CLATME( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void CLATME_( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatme( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatme_( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void ZLATME( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void ZLATME_( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatme( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatme_( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void DLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void DLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void dlatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void dlatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void SLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void SLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void slatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void slatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void CLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void CLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void clatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void clatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void ZLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void ZLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void zlatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void zlatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void DLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void DLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void dlatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void dlatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void SLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void SLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void slatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void slatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void CLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void CLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void ZLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void ZLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void DLAKF2( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void DLAKF2_( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void dlakf2( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void dlakf2_( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void SLAKF2( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void SLAKF2_( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void slakf2( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void slakf2_( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void CLAKF2( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void CLAKF2_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void clakf2( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void clakf2_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void ZLAKF2( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void ZLAKF2_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void zlakf2( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void zlakf2_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void DLARGE( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void DLARGE_( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void dlarge( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void dlarge_( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void SLARGE( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void SLARGE_( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void slarge( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void slarge_( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void CLARGE( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLARGE_( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clarge( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clarge_( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void ZLARGE( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLARGE_( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlarge( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlarge_( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); double DLARND( const int* idist, int* iseed ); double DLARND_( const int* idist, int* iseed ); double dlarnd( const int* idist, int* iseed ); double dlarnd_( const int* idist, int* iseed ); float SLARND( const int* idist, int* iseed ); float SLARND_( const int* idist, int* iseed ); float slarnd( const int* idist, int* iseed ); float slarnd_( const int* idist, int* iseed ); void CLARND( MKL_Complex8* retval, const int* idist, int* iseed ); void CLARND_( MKL_Complex8* retval, const int* idist, int* iseed ); void clarnd( MKL_Complex8* retval, const int* idist, int* iseed ); void clarnd_( MKL_Complex8* retval, const int* idist, int* iseed ); void ZLARND( MKL_Complex16* retval, const int* idist, int* iseed ); void ZLARND_( MKL_Complex16* retval, const int* idist, int* iseed ); void zlarnd( MKL_Complex16* retval, const int* idist, int* iseed ); void zlarnd_( MKL_Complex16* retval, const int* idist, int* iseed ); void DLAROR( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void DLAROR_( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void dlaror( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void dlaror_( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void SLAROR( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void SLAROR_( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void slaror( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void slaror_( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void CLAROR( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void CLAROR_( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void claror( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void claror_( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void ZLAROR( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void ZLAROR_( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void zlaror( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void zlaror_( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void DLAROT( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void DLAROT_( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void dlarot( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void dlarot_( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void SLAROT( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void SLAROT_( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void slarot( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void slarot_( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void CLAROT( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void CLAROT_( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void clarot( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void clarot_( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void ZLAROT( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); void ZLAROT_( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); void zlarot( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); void zlarot_( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); double DLARAN( int* iseed ); double DLARAN_( int* iseed ); double dlaran( int* iseed ); double dlaran_( int* iseed ); float SLARAN( int* iseed ); float SLARAN_( int* iseed ); float slaran( int* iseed ); float slaran_( int* iseed ); void DLAGGE( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void DLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagge( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagge_( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void SLAGGE( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void SLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagge( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagge_( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void CLAGGE( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagge( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagge_( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void ZLAGGE( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagge( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagge_( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void CLAGSY( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLAGSY_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagsy( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagsy_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void DLAGSY( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void DLAGSY_( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagsy( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagsy_( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void SLAGSY( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void SLAGSY_( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagsy( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagsy_( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void ZLAGSY( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLAGSY_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagsy( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagsy_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void CLAGHE( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLAGHE_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void claghe( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void claghe_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void ZLAGHE( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLAGHE_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlaghe( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlaghe_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void MKL_CSPFFRT2( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrt2( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrt2_( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void MKL_CSPFFRTX( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrtx( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrtx_( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void MKL_DSPFFRT2( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrt2( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrt2_( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void MKL_DSPFFRTX( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrtx( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrtx_( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void MKL_SSPFFRT2( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrt2( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrt2_( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void MKL_SSPFFRTX( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrtx( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrtx_( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void MKL_ZSPFFRT2( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrt2( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrt2_( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void MKL_ZSPFFRTX( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrtx( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrtx_( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); int MKL_PROGRESS( int* thread, int* step, char* stage, int lstage ); int MKL_PROGRESS_( int* thread, int* step, char* stage, int lstage ); int mkl_progress( int* thread, int* step, char* stage, int lstage ); int mkl_progress_( int* thread, int* step, char* stage, int lstage ); #line 44 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_lapacke.h" typedef int (*LAPACK_S_SELECT2) ( const float*, const float* ); typedef int (*LAPACK_S_SELECT3) ( const float*, const float*, const float* ); typedef int (*LAPACK_D_SELECT2) ( const double*, const double* ); typedef int (*LAPACK_D_SELECT3) ( const double*, const double*, const double* ); typedef int (*LAPACK_C_SELECT1) ( const MKL_Complex8* ); typedef int (*LAPACK_C_SELECT2) ( const MKL_Complex8*, const MKL_Complex8* ); typedef int (*LAPACK_Z_SELECT1) ( const MKL_Complex16* ); typedef int (*LAPACK_Z_SELECT2) ( const MKL_Complex16*, const MKL_Complex16* ); double LAPACKE_dlamch( char cmach ); double LAPACKE_dlamch_work( char cmach ); double LAPACKE_dlange( int matrix_layout, char norm, int m, int n, const double* a, int lda ); double LAPACKE_dlange_work( int matrix_layout, char norm, int m, int n, const double* a, int lda, double* work ); double LAPACKE_dlansy( int matrix_layout, char norm, char uplo, int n, const double* a, int lda ); double LAPACKE_dlansy_work( int matrix_layout, char norm, char uplo, int n, const double* a, int lda, double* work ); double LAPACKE_dlantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const double* a, int lda ); double LAPACKE_dlantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const double* a, int lda, double* work ); double LAPACKE_dlapy2( double x, double y ); double LAPACKE_dlapy2_work( double x, double y ); double LAPACKE_dlapy3( double x, double y, double z ); double LAPACKE_dlapy3_work( double x, double y, double z ); double LAPACKE_zlange( int matrix_layout, char norm, int m, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlange_work( int matrix_layout, char norm, int m, int n, const MKL_Complex16* a, int lda, double* work ); double LAPACKE_zlanhe( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlanhe_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda, double* work ); int LAPACKE_zlarcm( int matrix_layout, int m, int n, const double* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc ); int LAPACKE_zlarcm_work( int matrix_layout, int m, int n, const double* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, double* work ); int LAPACKE_zlacrm( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, const double* b, int ldb, MKL_Complex16* c, int ldc ); int LAPACKE_zlacrm_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, const double* b, int ldb, MKL_Complex16* c, int ldc, double* work ); double LAPACKE_zlansy( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlansy_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda, double* work ); double LAPACKE_zlantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex16* a, int lda, double* work ); float LAPACKE_clange( int matrix_layout, char norm, int m, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clange_work( int matrix_layout, char norm, int m, int n, const MKL_Complex8* a, int lda, float* work ); float LAPACKE_clanhe( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clanhe_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda, float* work ); int LAPACKE_clarcm( int matrix_layout, int m, int n, const float* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc ); int LAPACKE_clarcm_work( int matrix_layout, int m, int n, const float* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, float* rwork ); int LAPACKE_clacrm( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, const float* b, int ldb, MKL_Complex8* c, int ldc ); int LAPACKE_clacrm_work( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, const float* b, int ldb, MKL_Complex8* c, int ldc, float* rwork ); float LAPACKE_clansy( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clansy_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda, float* work ); float LAPACKE_clantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex8* a, int lda, float* work ); float LAPACKE_slamch( char cmach ); float LAPACKE_slamch_work( char cmach ); float LAPACKE_slange( int matrix_layout, char norm, int m, int n, const float* a, int lda ); float LAPACKE_slange_work( int matrix_layout, char norm, int m, int n, const float* a, int lda, float* work ); float LAPACKE_slansy( int matrix_layout, char norm, char uplo, int n, const float* a, int lda ); float LAPACKE_slansy_work( int matrix_layout, char norm, char uplo, int n, const float* a, int lda, float* work ); float LAPACKE_slantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const float* a, int lda ); float LAPACKE_slantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const float* a, int lda, float* work ); float LAPACKE_slapy2( float x, float y ); float LAPACKE_slapy2_work( float x, float y ); float LAPACKE_slapy3( float x, float y, float z ); float LAPACKE_slapy3_work( float x, float y, float z ); int LAPACKE_cbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e ); int LAPACKE_cbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, int lrwork ); int LAPACKE_cbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, MKL_Complex8* vt, int ldvt, MKL_Complex8* u, int ldu, MKL_Complex8* c, int ldc ); int LAPACKE_cbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, MKL_Complex8* vt, int ldvt, MKL_Complex8* u, int ldu, MKL_Complex8* c, int ldc, float* work ); int LAPACKE_cgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq, MKL_Complex8* pt, int ldpt, MKL_Complex8* c, int ldc ); int LAPACKE_cgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq, MKL_Complex8* pt, int ldpt, MKL_Complex8* c, int ldc, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbcon( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, const int* ipiv, float anorm, float* rcond ); int LAPACKE_cgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbequ( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbequb( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_cgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbtrf( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex8* ab, int ldab, int* ipiv ); int LAPACKE_cgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex8* ab, int ldab, int* ipiv ); int LAPACKE_cgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cgebal( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_cgebal_work( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_cgebrd( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup ); int LAPACKE_cgebrd_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int lwork ); int LAPACKE_cgecon( int matrix_layout, char norm, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond ); int LAPACKE_cgecon_work( int matrix_layout, char norm, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cgeequ( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgeequ_work( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgeequb( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgeequb_work( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgees( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs ); int LAPACKE_cgees_work( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cgeesx( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, char sense, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs, float* rconde, float* rcondv ); int LAPACKE_cgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, char sense, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cgeev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr ); int LAPACKE_cgeev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv ); int LAPACKE_cgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgehrd( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgehrd_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex8* a, int lda, float* sva, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, float* stat, int* istat ); int LAPACKE_cgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex8* a, int lda, float* sva, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* cwork, int lwork, float* rwork, int lrwork, int* iwork ); int LAPACKE_cgelq2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgelq2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work ); int LAPACKE_cgelqf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgelqf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgels( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cgels_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_cgelsd( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_cgelsd_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cgelss( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_cgelss_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgelsy( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* jpvt, float rcond, int* rank ); int LAPACKE_cgelsy_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* jpvt, float rcond, int* rank, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc ); int LAPACKE_cgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_cgeqlf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqlf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqp3( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau ); int LAPACKE_cgeqp3_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgeqpf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau ); int LAPACKE_cgeqpf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork ); int LAPACKE_cgeqr2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqr2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work ); int LAPACKE_cgeqrf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqrf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqrfp( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqrfp_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqrt( int matrix_layout, int m, int n, int nb, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt3( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt3_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt_work( int matrix_layout, int m, int n, int nb, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt, MKL_Complex8* work ); int LAPACKE_cgerfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cgerfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgerqf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgerqf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgesdd( int matrix_layout, char jobz, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt ); int LAPACKE_cgesdd_work( int matrix_layout, char jobz, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cgesv( int matrix_layout, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgesv_work( int matrix_layout, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, float* superb ); int LAPACKE_cgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, int* superb ); int LAPACKE_cgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex8 * a, int lda, float* sva, int mv, MKL_Complex8* v, int ldv, float* stat ); int LAPACKE_cgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex8* a, int lda, float* sva, int mv, MKL_Complex8* v, int ldv, MKL_Complex8* cwork, int lwork, float* rwork, int lrwork ); int LAPACKE_cgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_cgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgetf2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetf2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetri( int matrix_layout, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_cgetri_work( int matrix_layout, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_cgetrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgetrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cggbal( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale ); int LAPACKE_cggbal_work( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work ); int LAPACKE_cgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr ); int LAPACKE_cgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr ); int LAPACKE_cgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, float* rconde, float* rcondv ); int LAPACKE_cggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int liwork, int* bwork ); int LAPACKE_cggev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr ); int LAPACKE_cggev3( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr ); int LAPACKE_cggev3_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cggev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv ); int LAPACKE_cggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* bwork ); int LAPACKE_cggglm( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y ); int LAPACKE_cggglm_work( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, int lwork ); int LAPACKE_cgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_cgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork ); int LAPACKE_cgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_cgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_cgglse( int matrix_layout, int m, int n, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x ); int LAPACKE_cgglse_work( int matrix_layout, int m, int n, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, int lwork ); int LAPACKE_cggqrf( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub ); int LAPACKE_cggqrf_work( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub, MKL_Complex8* work, int lwork ); int LAPACKE_cggrqf( int matrix_layout, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub ); int LAPACKE_cggrqf_work( int matrix_layout, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub, MKL_Complex8* work, int lwork ); int LAPACKE_cggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork ); int LAPACKE_cggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork ); int LAPACKE_cggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, MKL_Complex8* work, float* rwork, int* iwork ); int LAPACKE_cggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq ); int LAPACKE_cggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq ); int LAPACKE_cggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work ); int LAPACKE_cgtcon( char norm, int n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, float anorm, float* rcond ); int LAPACKE_cgtcon_work( char norm, int n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_cgtrfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgtsv( int matrix_layout, int n, int nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, int ldb ); int LAPACKE_cgtsv_work( int matrix_layout, int n, int nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, int ldb ); int LAPACKE_cgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgttrf( int n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv ); int LAPACKE_cgttrf_work( int n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv ); int LAPACKE_cgttrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgttrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chbev( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chbevd( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, const MKL_Complex8* bb, int ldbb, MKL_Complex8* x, int ldx ); int LAPACKE_chbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, const MKL_Complex8* bb, int ldbb, MKL_Complex8* x, int ldx, MKL_Complex8* work, float* rwork ); int LAPACKE_chbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chbtrd( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq ); int LAPACKE_chbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq, MKL_Complex8* work ); int LAPACKE_checon( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond ); int LAPACKE_checon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_cheequb( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cheequb_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax, MKL_Complex8* work ); int LAPACKE_cheev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cheevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevr( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz ); int LAPACKE_cheevr_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_cheevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_chegst( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb ); int LAPACKE_chegst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb ); int LAPACKE_chegv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w ); int LAPACKE_chegv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chegvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w ); int LAPACKE_chegvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chegvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chegvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_cherfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cherfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cherfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cherfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_chesv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chesv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_chesvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_chesvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chesvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_chesvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cheswapr( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_cheswapr_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_chetrd( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tau ); int LAPACKE_chetrd_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_chetrf_rook( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_chetrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetri( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_chetri2( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_chetri2_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetri2x( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, int nb ); int LAPACKE_chetri2x_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int nb ); int LAPACKE_chetri_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work ); int LAPACKE_chetrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work ); int LAPACKE_chetrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const MKL_Complex8* a, int lda, float beta, MKL_Complex8* c ); int LAPACKE_chfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const MKL_Complex8* a, int lda, float beta, MKL_Complex8* c ); int LAPACKE_chgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* t, int ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_chgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* t, int ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chpcon( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond ); int LAPACKE_chpcon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_chpev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chpevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chpevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chpevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chpgst( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* ap, const MKL_Complex8* bp ); int LAPACKE_chpgst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* ap, const MKL_Complex8* bp ); int LAPACKE_chpgv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chpgvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chpgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chpgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_chprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_chpsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chpsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chpsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_chpsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_chptrd( int matrix_layout, char uplo, int n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau ); int LAPACKE_chptrd_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau ); int LAPACKE_chptrf( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_chptrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_chptri( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv ); int LAPACKE_chptri_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work ); int LAPACKE_chptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chsein( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_chsein_work( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr ); int LAPACKE_chseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* z, int ldz ); int LAPACKE_chseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork ); int LAPACKE_clacgv( int n, MKL_Complex8* x, int incx ); int LAPACKE_clacgv_work( int n, MKL_Complex8* x, int incx ); int LAPACKE_clacn2( int n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); int LAPACKE_clacn2_work( int n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); int LAPACKE_clacp2( int matrix_layout, char uplo, int m, int n, const float* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clacp2_work( int matrix_layout, char uplo, int m, int n, const float* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clacpy( int matrix_layout, char uplo, int m, int n, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clacpy_work( int matrix_layout, char uplo, int m, int n, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clag2z( int matrix_layout, int m, int n, const MKL_Complex8* sa, int ldsa, MKL_Complex16* a, int lda ); int LAPACKE_clag2z_work( int matrix_layout, int m, int n, const MKL_Complex8* sa, int ldsa, MKL_Complex16* a, int lda ); int LAPACKE_clagge( int matrix_layout, int m, int n, int kl, int ku, const float* d, MKL_Complex8* a, int lda, int* iseed ); int LAPACKE_clagge_work( int matrix_layout, int m, int n, int kl, int ku, const float* d, MKL_Complex8* a, int lda, int* iseed, MKL_Complex8* work ); int LAPACKE_claghe( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed ); int LAPACKE_claghe_work( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed, MKL_Complex8* work ); int LAPACKE_clagsy( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed ); int LAPACKE_clagsy_work( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed, MKL_Complex8* work ); int LAPACKE_clapmr( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clapmr_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clapmt( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clapmt_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc ); int LAPACKE_clarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc, MKL_Complex8* work, int ldwork ); int LAPACKE_clarfg( int n, MKL_Complex8* alpha, MKL_Complex8* x, int incx, MKL_Complex8* tau ); int LAPACKE_clarfg_work( int n, MKL_Complex8* alpha, MKL_Complex8* x, int incx, MKL_Complex8* tau ); int LAPACKE_clarft( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* tau, MKL_Complex8* t, int ldt ); int LAPACKE_clarft_work( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* tau, MKL_Complex8* t, int ldt ); int LAPACKE_clarfx( int matrix_layout, char side, int m, int n, const MKL_Complex8* v, MKL_Complex8 tau, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_clarfx_work( int matrix_layout, char side, int m, int n, const MKL_Complex8* v, MKL_Complex8 tau, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_clarnv( int idist, int* iseed, int n, MKL_Complex8* x ); int LAPACKE_clarnv_work( int idist, int* iseed, int n, MKL_Complex8* x ); int LAPACKE_clascl( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_clascl_work( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_claset( int matrix_layout, char uplo, int m, int n, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8* a, int lda ); int LAPACKE_claset_work( int matrix_layout, char uplo, int m, int n, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8* a, int lda ); int LAPACKE_claswp( int matrix_layout, int n, MKL_Complex8* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_claswp_work( int matrix_layout, int n, MKL_Complex8* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_clatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, MKL_Complex8* a, int lda ); int LAPACKE_clatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, MKL_Complex8* a, int lda, MKL_Complex8* work ); int LAPACKE_clauum( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_clauum_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpbcon( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float anorm, float* rcond ); int LAPACKE_cpbcon_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cpbequ( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_cpbequ_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_cpbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cpbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpbstf( int matrix_layout, char uplo, int n, int kb, MKL_Complex8* bb, int ldbb ); int LAPACKE_cpbstf_work( int matrix_layout, char uplo, int n, int kb, MKL_Complex8* bb, int ldbb ); int LAPACKE_cpbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cpbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpbtrf( int matrix_layout, char uplo, int n, int kd, MKL_Complex8* ab, int ldab ); int LAPACKE_cpbtrf_work( int matrix_layout, char uplo, int n, int kd, MKL_Complex8* ab, int ldab ); int LAPACKE_cpbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpftrf( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftrf_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftri( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftri_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_cpftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_cpocon( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond ); int LAPACKE_cpocon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cpoequ( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cpoequ_work( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cpoequb( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cpoequb_work( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cporfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cporfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cposv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cposv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cpotrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrf2( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrf2_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotri( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotri_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cpotrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cppcon( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float anorm, float* rcond ); int LAPACKE_cppcon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cppequ( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float* s, float* scond, float* amax ); int LAPACKE_cppequ_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float* s, float* scond, float* amax ); int LAPACKE_cpprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cpprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cppsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cppsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpptrf( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptri( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptri_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cpptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cpstrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* piv, int* rank, float tol ); int LAPACKE_cpstrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* piv, int* rank, float tol, float* work ); int LAPACKE_cptcon( int n, const float* d, const MKL_Complex8* e, float anorm, float* rcond ); int LAPACKE_cptcon_work( int n, const float* d, const MKL_Complex8* e, float anorm, float* rcond, float* work ); int LAPACKE_cpteqr( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz ); int LAPACKE_cpteqr_work( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz, float* work ); int LAPACKE_cptrfs( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cptrfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cptsv( int matrix_layout, int n, int nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cptsv_work( int matrix_layout, int n, int nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cptsvx( int matrix_layout, char fact, int n, int nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cptsvx_work( int matrix_layout, char fact, int n, int nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpttrf( int n, float* d, MKL_Complex8* e ); int LAPACKE_cpttrf_work( int n, float* d, MKL_Complex8* e ); int LAPACKE_cpttrs( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cpttrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cspcon( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond ); int LAPACKE_cspcon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_csprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_csprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cspsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cspsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_csptrf( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_csptrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_csptri( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv ); int LAPACKE_csptri_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work ); int LAPACKE_csptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cstedc( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz ); int LAPACKE_cstedc_work( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cstegr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz ); int LAPACKE_cstegr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_cstein( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, int ldz, int* ifailv ); int LAPACKE_cstein_work( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, int ldz, float* work, int* iwork, int* ifailv ); int LAPACKE_cstemr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, MKL_Complex8* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_cstemr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, MKL_Complex8* z, int ldz, int nzc, int* isuppz, int* tryrac, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_csteqr( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz ); int LAPACKE_csteqr_work( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz, float* work ); int LAPACKE_csycon( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond ); int LAPACKE_csycon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_csyconv( int matrix_layout, char uplo, char way, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* e ); int LAPACKE_csyconv_work( int matrix_layout, char uplo, char way, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* e ); int LAPACKE_csyequb( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_csyequb_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax, MKL_Complex8* work ); int LAPACKE_csyr( int matrix_layout, char uplo, int n, MKL_Complex8 alpha, const MKL_Complex8* x, int incx, MKL_Complex8* a, int lda ); int LAPACKE_csyr_work( int matrix_layout, char uplo, int n, MKL_Complex8 alpha, const MKL_Complex8* x, int incx, MKL_Complex8* a, int lda ); int LAPACKE_csyrfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_csyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_csyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_csyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_csysv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_rook( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csysv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_csysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_csysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_csysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_csyswapr( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_csyswapr_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_csytrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_csytrf_rook( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_csytrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytri( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_csytri2( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_csytri2_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytri2x( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, int nb ); int LAPACKE_csytri2x_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int nb ); int LAPACKE_csytri_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work ); int LAPACKE_csytrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work ); int LAPACKE_csytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_ctbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex8* ab, int ldab, float* rcond ); int LAPACKE_ctbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex8* ab, int ldab, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_ctbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_ctbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_ctbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_ctbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_ctfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex8 alpha, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_ctfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex8 alpha, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_ctftri( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex8* a ); int LAPACKE_ctftri_work( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex8* a ); int LAPACKE_ctfttp( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* ap ); int LAPACKE_ctfttp_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* ap ); int LAPACKE_ctfttr( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* a, int lda ); int LAPACKE_ctfttr_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* a, int lda ); int LAPACKE_ctgevc( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex8* s, int lds, const MKL_Complex8* p, int ldp, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m ); int LAPACKE_ctgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex8* s, int lds, const MKL_Complex8* p, int ldp, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, MKL_Complex8* work, float* rwork ); int LAPACKE_ctgexc( int matrix_layout, int wantq, int wantz, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int ifst, int ilst ); int LAPACKE_ctgexc_work( int matrix_layout, int wantq, int wantz, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int ifst, int ilst ); int LAPACKE_ctgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int* m, float* pl, float* pr, float* dif ); int LAPACKE_ctgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, int lwork, int* iwork, int liwork ); int LAPACKE_ctgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* ncycle ); int LAPACKE_ctgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, MKL_Complex8* work, int* ncycle ); int LAPACKE_ctgsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* dif, int mm, int* m ); int LAPACKE_ctgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* dif, int mm, int* m, MKL_Complex8* work, int lwork, int* iwork ); int LAPACKE_ctgsyl( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, const MKL_Complex8* d, int ldd, const MKL_Complex8* e, int lde, MKL_Complex8* f, int ldf, float* scale, float* dif ); int LAPACKE_ctgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, const MKL_Complex8* d, int ldd, const MKL_Complex8* e, int lde, MKL_Complex8* f, int ldf, float* scale, float* dif, MKL_Complex8* work, int lwork, int* iwork ); int LAPACKE_ctpcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* ap, float* rcond ); int LAPACKE_ctpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_ctpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work ); int LAPACKE_ctpqrt( int matrix_layout, int m, int n, int l, int nb, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt ); int LAPACKE_ctpqrt2( int matrix_layout, int m, int n, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt ); int LAPACKE_ctpqrt2_work( int matrix_layout, int m, int n, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt ); int LAPACKE_ctpqrt_work( int matrix_layout, int m, int n, int l, int nb, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt, MKL_Complex8* work ); int LAPACKE_ctprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work, int ldwork ); int LAPACKE_ctprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_ctprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_ctptri( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* ap ); int LAPACKE_ctptri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* ap ); int LAPACKE_ctptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_ctptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_ctpttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* arf ); int LAPACKE_ctpttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* arf ); int LAPACKE_ctpttr( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* a, int lda ); int LAPACKE_ctpttr_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* a, int lda ); int LAPACKE_ctrcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* a, int lda, float* rcond ); int LAPACKE_ctrcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* a, int lda, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_ctrevc( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m ); int LAPACKE_ctrevc_work( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, MKL_Complex8* work, float* rwork ); int LAPACKE_ctrexc( int matrix_layout, char compq, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, int ifst, int ilst ); int LAPACKE_ctrexc_work( int matrix_layout, char compq, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, int ifst, int ilst ); int LAPACKE_ctrrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_ctrrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_ctrsen( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, MKL_Complex8* w, int* m, float* s, float* sep ); int LAPACKE_ctrsen_work( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, int lwork ); int LAPACKE_ctrsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* t, int ldt, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* sep, int mm, int* m ); int LAPACKE_ctrsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* t, int ldt, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* sep, int mm, int* m, MKL_Complex8* work, int ldwork, float* rwork ); int LAPACKE_ctrsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, float* scale ); int LAPACKE_ctrsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, float* scale ); int LAPACKE_ctrtri( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* a, int lda ); int LAPACKE_ctrtri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* a, int lda ); int LAPACKE_ctrtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctrtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctrttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* arf ); int LAPACKE_ctrttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* arf ); int LAPACKE_ctrttp( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* ap ); int LAPACKE_ctrttp_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* ap ); int LAPACKE_ctzrzf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_ctzrzf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunbdb( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2 ); int LAPACKE_cunbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, int lwork ); int LAPACKE_cuncsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t ); int LAPACKE_cuncsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x21, int ldx21, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t ); int LAPACKE_cuncsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x21, int ldx21, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork ); int LAPACKE_cuncsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork ); int LAPACKE_cungbr( int matrix_layout, char vect, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungbr_work( int matrix_layout, char vect, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunghr( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cunghr_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunglq( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cunglq_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungql( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungql_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungqr( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungqr_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungrq( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungrq_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungtr( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungtr_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunmbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmql( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmql_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmrq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cupgtr( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, int ldq ); int LAPACKE_cupgtr_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, int ldq, MKL_Complex8* work ); int LAPACKE_cupmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cupmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_dbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e ); int LAPACKE_dbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* work, int lwork ); int LAPACKE_dbdsdc( int matrix_layout, char uplo, char compq, int n, double* d, double* e, double* u, int ldu, double* vt, int ldvt, double* q, int* iq ); int LAPACKE_dbdsdc_work( int matrix_layout, char uplo, char compq, int n, double* d, double* e, double* u, int ldu, double* vt, int ldvt, double* q, int* iq, double* work, int* iwork ); int LAPACKE_dbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, double* vt, int ldvt, double* u, int ldu, double* c, int ldc ); int LAPACKE_dbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, double* vt, int ldvt, double* u, int ldu, double* c, int ldc, double* work ); int LAPACKE_dbdsvdx( int matrix_layout, char uplo, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* ns, double* s, double* z, int ldz, int* superb ); int LAPACKE_dbdsvdx_work( int matrix_layout, char uplo, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* ns, double* s, double* z, int ldz, double* work, int* iwork ); int LAPACKE_ddisna( char job, int m, int n, const double* d, double* sep ); int LAPACKE_ddisna_work( char job, int m, int n, const double* d, double* sep ); int LAPACKE_dgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, double* ab, int ldab, double* d, double* e, double* q, int ldq, double* pt, int ldpt, double* c, int ldc ); int LAPACKE_dgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, double* ab, int ldab, double* d, double* e, double* q, int ldq, double* pt, int ldpt, double* c, int ldc, double* work ); int LAPACKE_dgbcon( int matrix_layout, char norm, int n, int kl, int ku, const double* ab, int ldab, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const double* ab, int ldab, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dgbequ( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbequb( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, double* ab, int ldab, int* ipiv, double* b, int ldb ); int LAPACKE_dgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, double* ab, int ldab, int* ipiv, double* b, int ldb ); int LAPACKE_dgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_dgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgbtrf( int matrix_layout, int m, int n, int kl, int ku, double* ab, int ldab, int* ipiv ); int LAPACKE_dgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, double* ab, int ldab, int* ipiv ); int LAPACKE_dgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const int* ipiv, double* b, int ldb ); int LAPACKE_dgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const int* ipiv, double* b, int ldb ); int LAPACKE_dgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, double* v, int ldv ); int LAPACKE_dgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, double* v, int ldv ); int LAPACKE_dgebal( int matrix_layout, char job, int n, double* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_dgebal_work( int matrix_layout, char job, int n, double* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_dgebrd( int matrix_layout, int m, int n, double* a, int lda, double* d, double* e, double* tauq, double* taup ); int LAPACKE_dgebrd_work( int matrix_layout, int m, int n, double* a, int lda, double* d, double* e, double* tauq, double* taup, double* work, int lwork ); int LAPACKE_dgecon( int matrix_layout, char norm, int n, const double* a, int lda, double anorm, double* rcond ); int LAPACKE_dgecon_work( int matrix_layout, char norm, int n, const double* a, int lda, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dgeequ( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgeequ_work( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgeequb( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgeequb_work( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgees( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs ); int LAPACKE_dgees_work( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs, double* work, int lwork, int* bwork ); int LAPACKE_dgeesx( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, char sense, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs, double* rconde, double* rcondv ); int LAPACKE_dgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, char sense, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs, double* rconde, double* rcondv, double* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_dgeev( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr ); int LAPACKE_dgeev_work( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr, double* work, int lwork ); int LAPACKE_dgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv ); int LAPACKE_dgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, int lwork, int* iwork ); int LAPACKE_dgehrd( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, double* tau ); int LAPACKE_dgehrd_work( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, double* a, int lda, double* sva, double* u, int ldu, double* v, int ldv, double* stat, int* istat ); int LAPACKE_dgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, double* a, int lda, double* sva, double* u, int ldu, double* v, int ldv, double* work, int lwork, int* iwork ); int LAPACKE_dgelq2( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgelq2_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work ); int LAPACKE_dgelqf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgelqf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgels( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dgels_work( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* work, int lwork ); int LAPACKE_dgelsd( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_dgelsd_work( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank, double* work, int lwork, int* iwork ); int LAPACKE_dgelss( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_dgelss_work( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank, double* work, int lwork ); int LAPACKE_dgelsy( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, int* jpvt, double rcond, int* rank ); int LAPACKE_dgelsy_work( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, int* jpvt, double rcond, int* rank, double* work, int lwork ); int LAPACKE_dgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const double* v, int ldv, const double* t, int ldt, double* c, int ldc ); int LAPACKE_dgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const double* v, int ldv, const double* t, int ldt, double* c, int ldc, double* work ); int LAPACKE_dgeqlf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqlf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgeqp3( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau ); int LAPACKE_dgeqp3_work( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau, double* work, int lwork ); int LAPACKE_dgeqpf( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau ); int LAPACKE_dgeqpf_work( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau, double* work ); int LAPACKE_dgeqr2( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqr2_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work ); int LAPACKE_dgeqrf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqrf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgeqrfp( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqrfp_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgeqrt( int matrix_layout, int m, int n, int nb, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt2( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt2_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt3( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt3_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt_work( int matrix_layout, int m, int n, int nb, double* a, int lda, double* t, int ldt, double* work ); int LAPACKE_dgerfs( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dgerfs_work( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgerqf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgerqf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgesdd( int matrix_layout, char jobz, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt ); int LAPACKE_dgesdd_work( int matrix_layout, char jobz, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt, double* work, int lwork, int* iwork ); int LAPACKE_dgesv( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dgesv_work( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt, double* superb ); int LAPACKE_dgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt, double* work, int lwork ); int LAPACKE_dgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, double* a, int lda, double vl, double vu, int il, int iu, int *ns, double* s, double* u, int ldu, double* vt, int ldvt, int* superb ); int LAPACKE_dgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, double* a, int lda, double vl, double vu, int il, int iu, int *ns, double* s, double* u, int ldu, double* vt, int ldvt, double* work, int lwork, int* iwork ); int LAPACKE_dgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, double* a, int lda, double* sva, int mv, double* v, int ldv, double* stat ); int LAPACKE_dgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, double* a, int lda, double* sva, int mv, double* v, int ldv, double* work, int lwork ); int LAPACKE_dgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_dgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgetf2( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetf2_work( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf2( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf2_work( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf_work( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetri( int matrix_layout, int n, double* a, int lda, const int* ipiv ); int LAPACKE_dgetri_work( int matrix_layout, int n, double* a, int lda, const int* ipiv, double* work, int lwork ); int LAPACKE_dgetrs( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dgetrs_work( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, double* v, int ldv ); int LAPACKE_dggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, double* v, int ldv ); int LAPACKE_dggbal( int matrix_layout, char job, int n, double* a, int lda, double* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale ); int LAPACKE_dggbal_work( int matrix_layout, char job, int n, double* a, int lda, double* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work ); int LAPACKE_dgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr ); int LAPACKE_dgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr ); int LAPACKE_dgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* work, int lwork, int* bwork ); int LAPACKE_dgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* work, int lwork, int* bwork ); int LAPACKE_dggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, char sense, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* rconde, double* rcondv ); int LAPACKE_dggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, char sense, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* rconde, double* rcondv, double* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_dggev( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr ); int LAPACKE_dggev3( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr ); int LAPACKE_dggev3_work( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, double* work, int lwork ); int LAPACKE_dggev_work( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, double* work, int lwork ); int LAPACKE_dggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv ); int LAPACKE_dggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, int lwork, int* iwork, int* bwork ); int LAPACKE_dggglm( int matrix_layout, int n, int m, int p, double* a, int lda, double* b, int ldb, double* d, double* x, double* y ); int LAPACKE_dggglm_work( int matrix_layout, int n, int m, int p, double* a, int lda, double* b, int ldb, double* d, double* x, double* y, double* work, int lwork ); int LAPACKE_dgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz ); int LAPACKE_dgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz, double* work, int lwork ); int LAPACKE_dgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz ); int LAPACKE_dgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz ); int LAPACKE_dgglse( int matrix_layout, int m, int n, int p, double* a, int lda, double* b, int ldb, double* c, double* d, double* x ); int LAPACKE_dgglse_work( int matrix_layout, int m, int n, int p, double* a, int lda, double* b, int ldb, double* c, double* d, double* x, double* work, int lwork ); int LAPACKE_dggqrf( int matrix_layout, int n, int m, int p, double* a, int lda, double* taua, double* b, int ldb, double* taub ); int LAPACKE_dggqrf_work( int matrix_layout, int n, int m, int p, double* a, int lda, double* taua, double* b, int ldb, double* taub, double* work, int lwork ); int LAPACKE_dggrqf( int matrix_layout, int m, int p, int n, double* a, int lda, double* taua, double* b, int ldb, double* taub ); int LAPACKE_dggrqf_work( int matrix_layout, int m, int p, int n, double* a, int lda, double* taua, double* b, int ldb, double* taub, double* work, int lwork ); int LAPACKE_dggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork ); int LAPACKE_dggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork ); int LAPACKE_dggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, double* work, int lwork, int* iwork ); int LAPACKE_dggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, double* work, int* iwork ); int LAPACKE_dggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq ); int LAPACKE_dggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq ); int LAPACKE_dggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork, double* tau, double* work, int lwork ); int LAPACKE_dggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork, double* tau, double* work ); int LAPACKE_dgtcon( char norm, int n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dgtcon_work( char norm, int n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dgtrfs( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgtsv( int matrix_layout, int n, int nrhs, double* dl, double* d, double* du, double* b, int ldb ); int LAPACKE_dgtsv_work( int matrix_layout, int n, int nrhs, double* dl, double* d, double* du, double* b, int ldb ); int LAPACKE_dgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgttrf( int n, double* dl, double* d, double* du, double* du2, int* ipiv ); int LAPACKE_dgttrf_work( int n, double* dl, double* d, double* du, double* du2, int* ipiv ); int LAPACKE_dgttrs( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, int ldb ); int LAPACKE_dgttrs_work( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, int ldb ); int LAPACKE_dhgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, double* h, int ldh, double* t, int ldt, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz ); int LAPACKE_dhgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, double* h, int ldh, double* t, int ldt, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz, double* work, int lwork ); int LAPACKE_dhsein( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const double* h, int ldh, double* wr, const double* wi, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_dhsein_work( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const double* h, int ldh, double* wr, const double* wi, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, double* work, int* ifaill, int* ifailr ); int LAPACKE_dhseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, double* h, int ldh, double* wr, double* wi, double* z, int ldz ); int LAPACKE_dhseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, double* h, int ldh, double* wr, double* wi, double* z, int ldz, double* work, int lwork ); int LAPACKE_dlacn2( int n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); int LAPACKE_dlacn2_work( int n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); int LAPACKE_dlacpy( int matrix_layout, char uplo, int m, int n, const double* a, int lda, double* b, int ldb ); int LAPACKE_dlacpy_work( int matrix_layout, char uplo, int m, int n, const double* a, int lda, double* b, int ldb ); int LAPACKE_dlag2s( int matrix_layout, int m, int n, const double* a, int lda, float* sa, int ldsa ); int LAPACKE_dlag2s_work( int matrix_layout, int m, int n, const double* a, int lda, float* sa, int ldsa ); int LAPACKE_dlagge( int matrix_layout, int m, int n, int kl, int ku, const double* d, double* a, int lda, int* iseed ); int LAPACKE_dlagge_work( int matrix_layout, int m, int n, int kl, int ku, const double* d, double* a, int lda, int* iseed, double* work ); int LAPACKE_dlagsy( int matrix_layout, int n, int k, const double* d, double* a, int lda, int* iseed ); int LAPACKE_dlagsy_work( int matrix_layout, int n, int k, const double* d, double* a, int lda, int* iseed, double* work ); int LAPACKE_dlapmr( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlapmr_work( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlapmt( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlapmt_work( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const double* v, int ldv, const double* t, int ldt, double* c, int ldc ); int LAPACKE_dlarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const double* v, int ldv, const double* t, int ldt, double* c, int ldc, double* work, int ldwork ); int LAPACKE_dlarfg( int n, double* alpha, double* x, int incx, double* tau ); int LAPACKE_dlarfg_work( int n, double* alpha, double* x, int incx, double* tau ); int LAPACKE_dlarft( int matrix_layout, char direct, char storev, int n, int k, const double* v, int ldv, const double* tau, double* t, int ldt ); int LAPACKE_dlarft_work( int matrix_layout, char direct, char storev, int n, int k, const double* v, int ldv, const double* tau, double* t, int ldt ); int LAPACKE_dlarfx( int matrix_layout, char side, int m, int n, const double* v, double tau, double* c, int ldc, double* work ); int LAPACKE_dlarfx_work( int matrix_layout, char side, int m, int n, const double* v, double tau, double* c, int ldc, double* work ); int LAPACKE_dlarnv( int idist, int* iseed, int n, double* x ); int LAPACKE_dlarnv_work( int idist, int* iseed, int n, double* x ); int LAPACKE_dlartgp( double f, double g, double* cs, double* sn, double* r ); int LAPACKE_dlartgp_work( double f, double g, double* cs, double* sn, double* r ); int LAPACKE_dlartgs( double x, double y, double sigma, double* cs, double* sn ); int LAPACKE_dlartgs_work( double x, double y, double sigma, double* cs, double* sn ); int LAPACKE_dlascl( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, double* a, int lda ); int LAPACKE_dlascl_work( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, double* a, int lda ); int LAPACKE_dlaset( int matrix_layout, char uplo, int m, int n, double alpha, double beta, double* a, int lda ); int LAPACKE_dlaset_work( int matrix_layout, char uplo, int m, int n, double alpha, double beta, double* a, int lda ); int LAPACKE_dlasrt( char id, int n, double* d ); int LAPACKE_dlasrt_work( char id, int n, double* d ); int LAPACKE_dlaswp( int matrix_layout, int n, double* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_dlaswp_work( int matrix_layout, int n, double* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_dlatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, double* a, int lda ); int LAPACKE_dlatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, double* a, int lda, double* work ); int LAPACKE_dlauum( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dlauum_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dopgtr( int matrix_layout, char uplo, int n, const double* ap, const double* tau, double* q, int ldq ); int LAPACKE_dopgtr_work( int matrix_layout, char uplo, int n, const double* ap, const double* tau, double* q, int ldq, double* work ); int LAPACKE_dopmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* ap, const double* tau, double* c, int ldc ); int LAPACKE_dopmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* ap, const double* tau, double* c, int ldc, double* work ); int LAPACKE_dorbdb( int matrix_layout, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2 ); int LAPACKE_dorbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, int lwork ); int LAPACKE_dorcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t ); int LAPACKE_dorcsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, double* x11, int ldx11, double* x21, int ldx21, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t ); int LAPACKE_dorcsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, double* x11, int ldx11, double* x21, int ldx21, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* work, int lwork, int* iwork ); int LAPACKE_dorcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t, double* work, int lwork, int* iwork ); int LAPACKE_dorgbr( int matrix_layout, char vect, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgbr_work( int matrix_layout, char vect, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorghr( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, const double* tau ); int LAPACKE_dorghr_work( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorglq( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorglq_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgql( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgql_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgqr( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgqr_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgrq( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgrq_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgtr( int matrix_layout, char uplo, int n, double* a, int lda, const double* tau ); int LAPACKE_dorgtr_work( int matrix_layout, char uplo, int n, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dormbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormlq( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormql( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormql_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormqr( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormrq( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dpbcon( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double anorm, double* rcond ); int LAPACKE_dpbcon_work( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dpbequ( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_dpbequ_work( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_dpbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dpbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dpbstf( int matrix_layout, char uplo, int n, int kb, double* bb, int ldbb ); int LAPACKE_dpbstf_work( int matrix_layout, char uplo, int n, int kb, double* bb, int ldbb ); int LAPACKE_dpbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* afb, int ldafb, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dpbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* afb, int ldafb, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dpbtrf( int matrix_layout, char uplo, int n, int kd, double* ab, int ldab ); int LAPACKE_dpbtrf_work( int matrix_layout, char uplo, int n, int kd, double* ab, int ldab ); int LAPACKE_dpbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpftrf( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftrf_work( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftri( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftri_work( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const double* a, double* b, int ldb ); int LAPACKE_dpftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const double* a, double* b, int ldb ); int LAPACKE_dpocon( int matrix_layout, char uplo, int n, const double* a, int lda, double anorm, double* rcond ); int LAPACKE_dpocon_work( int matrix_layout, char uplo, int n, const double* a, int lda, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dpoequ( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dpoequ_work( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dpoequb( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dpoequb_work( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dporfs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dporfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dposv( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dposv_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dpotrf( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrf2( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrf2_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrf_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotri( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotri_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dpotrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dppcon( int matrix_layout, char uplo, int n, const double* ap, double anorm, double* rcond ); int LAPACKE_dppcon_work( int matrix_layout, char uplo, int n, const double* ap, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dppequ( int matrix_layout, char uplo, int n, const double* ap, double* s, double* scond, double* amax ); int LAPACKE_dppequ_work( int matrix_layout, char uplo, int n, const double* ap, double* s, double* scond, double* amax ); int LAPACKE_dpprfs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dpprfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dppsv( int matrix_layout, char uplo, int n, int nrhs, double* ap, double* b, int ldb ); int LAPACKE_dppsv_work( int matrix_layout, char uplo, int n, int nrhs, double* ap, double* b, int ldb ); int LAPACKE_dppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* ap, double* afp, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* ap, double* afp, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dpptrf( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptrf_work( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptri( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptri_work( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptrs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dpptrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dpstrf( int matrix_layout, char uplo, int n, double* a, int lda, int* piv, int* rank, double tol ); int LAPACKE_dpstrf_work( int matrix_layout, char uplo, int n, double* a, int lda, int* piv, int* rank, double tol, double* work ); int LAPACKE_dptcon( int n, const double* d, const double* e, double anorm, double* rcond ); int LAPACKE_dptcon_work( int n, const double* d, const double* e, double anorm, double* rcond, double* work ); int LAPACKE_dpteqr( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dpteqr_work( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz, double* work ); int LAPACKE_dptrfs( int matrix_layout, int n, int nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dptrfs_work( int matrix_layout, int n, int nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work ); int LAPACKE_dptsv( int matrix_layout, int n, int nrhs, double* d, double* e, double* b, int ldb ); int LAPACKE_dptsv_work( int matrix_layout, int n, int nrhs, double* d, double* e, double* b, int ldb ); int LAPACKE_dptsvx( int matrix_layout, char fact, int n, int nrhs, const double* d, const double* e, double* df, double* ef, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dptsvx_work( int matrix_layout, char fact, int n, int nrhs, const double* d, const double* e, double* df, double* ef, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work ); int LAPACKE_dpttrf( int n, double* d, double* e ); int LAPACKE_dpttrf_work( int n, double* d, double* e ); int LAPACKE_dpttrs( int matrix_layout, int n, int nrhs, const double* d, const double* e, double* b, int ldb ); int LAPACKE_dpttrs_work( int matrix_layout, int n, int nrhs, const double* d, const double* e, double* b, int ldb ); int LAPACKE_dsbev( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work ); int LAPACKE_dsbevd( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, double* ab, int ldab, const double* bb, int ldbb, double* x, int ldx ); int LAPACKE_dsbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, double* ab, int ldab, const double* bb, int ldbb, double* x, int ldx, double* work ); int LAPACKE_dsbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz ); int LAPACKE_dsbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz, double* work ); int LAPACKE_dsbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz ); int LAPACKE_dsbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsbtrd( int matrix_layout, char vect, char uplo, int n, int kd, double* ab, int ldab, double* d, double* e, double* q, int ldq ); int LAPACKE_dsbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, double* ab, int ldab, double* d, double* e, double* q, int ldq, double* work ); int LAPACKE_dsfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const double* a, int lda, double beta, double* c ); int LAPACKE_dsfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const double* a, int lda, double beta, double* c ); int LAPACKE_dsgesv( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* x, int ldx, int* iter ); int LAPACKE_dsgesv_work( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* x, int ldx, double* work, float* swork, int* iter ); int LAPACKE_dspcon( int matrix_layout, char uplo, int n, const double* ap, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dspcon_work( int matrix_layout, char uplo, int n, const double* ap, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dspev( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz ); int LAPACKE_dspev_work( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz, double* work ); int LAPACKE_dspevd( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz ); int LAPACKE_dspevd_work( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dspevx( int matrix_layout, char jobz, char range, char uplo, int n, double* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dspevx_work( int matrix_layout, char jobz, char range, char uplo, int n, double* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dspgst( int matrix_layout, int itype, char uplo, int n, double* ap, const double* bp ); int LAPACKE_dspgst_work( int matrix_layout, int itype, char uplo, int n, double* ap, const double* bp ); int LAPACKE_dspgv( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz ); int LAPACKE_dspgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz, double* work ); int LAPACKE_dspgvd( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz ); int LAPACKE_dspgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dspgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* ap, double* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dspgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* ap, double* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsposv( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb, double* x, int ldx, int* iter ); int LAPACKE_dsposv_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb, double* x, int ldx, double* work, float* swork, int* iter ); int LAPACKE_dsprfs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dsprfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dspsv( int matrix_layout, char uplo, int n, int nrhs, double* ap, int* ipiv, double* b, int ldb ); int LAPACKE_dspsv_work( int matrix_layout, char uplo, int n, int nrhs, double* ap, int* ipiv, double* b, int ldb ); int LAPACKE_dspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* ap, double* afp, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* ap, double* afp, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dsptrd( int matrix_layout, char uplo, int n, double* ap, double* d, double* e, double* tau ); int LAPACKE_dsptrd_work( int matrix_layout, char uplo, int n, double* ap, double* d, double* e, double* tau ); int LAPACKE_dsptrf( int matrix_layout, char uplo, int n, double* ap, int* ipiv ); int LAPACKE_dsptrf_work( int matrix_layout, char uplo, int n, double* ap, int* ipiv ); int LAPACKE_dsptri( int matrix_layout, char uplo, int n, double* ap, const int* ipiv ); int LAPACKE_dsptri_work( int matrix_layout, char uplo, int n, double* ap, const int* ipiv, double* work ); int LAPACKE_dsptrs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const int* ipiv, double* b, int ldb ); int LAPACKE_dsptrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const int* ipiv, double* b, int ldb ); int LAPACKE_dstebz( char range, char order, int n, double vl, double vu, int il, int iu, double abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit ); int LAPACKE_dstebz_work( char range, char order, int n, double vl, double vu, int il, int iu, double abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork ); int LAPACKE_dstedc( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dstedc_work( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstegr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dstegr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstein( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, double* z, int ldz, int* ifailv ); int LAPACKE_dstein_work( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, double* z, int ldz, double* work, int* iwork, int* ifailv ); int LAPACKE_dstemr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, double* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_dstemr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, double* z, int ldz, int nzc, int* isuppz, int* tryrac, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsteqr( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dsteqr_work( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz, double* work ); int LAPACKE_dsterf( int n, double* d, double* e ); int LAPACKE_dsterf_work( int n, double* d, double* e ); int LAPACKE_dstev( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dstev_work( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz, double* work ); int LAPACKE_dstevd( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dstevd_work( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstevr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dstevr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstevx( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dstevx_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsycon( int matrix_layout, char uplo, int n, const double* a, int lda, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dsycon_work( int matrix_layout, char uplo, int n, const double* a, int lda, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dsyconv( int matrix_layout, char uplo, char way, int n, double* a, int lda, const int* ipiv, double* e ); int LAPACKE_dsyconv_work( int matrix_layout, char uplo, char way, int n, double* a, int lda, const int* ipiv, double* e ); int LAPACKE_dsyequb( int matrix_layout, char uplo, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dsyequb_work( int matrix_layout, char uplo, int n, const double* a, int lda, double* s, double* scond, double* amax, double* work ); int LAPACKE_dsyev( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyev_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork ); int LAPACKE_dsyevd( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyevd_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevr( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dsyevr_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevx( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsyevx_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsygst( int matrix_layout, int itype, char uplo, int n, double* a, int lda, const double* b, int ldb ); int LAPACKE_dsygst_work( int matrix_layout, int itype, char uplo, int n, double* a, int lda, const double* b, int ldb ); int LAPACKE_dsygv( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w ); int LAPACKE_dsygv_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w, double* work, int lwork ); int LAPACKE_dsygvd( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w ); int LAPACKE_dsygvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsygvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* a, int lda, double* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsygvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* a, int lda, double* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsyrfs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dsyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dsyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dsyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dsysv( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_rook( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsysv_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* a, int lda, double* af, int ldaf, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dsysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* a, int lda, double* af, int ldaf, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int lwork, int* iwork ); int LAPACKE_dsysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dsysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dsyswapr( int matrix_layout, char uplo, int n, double* a, int lda, int i1, int i2 ); int LAPACKE_dsyswapr_work( int matrix_layout, char uplo, int n, double* a, int lda, int i1, int i2 ); int LAPACKE_dsytrd( int matrix_layout, char uplo, int n, double* a, int lda, double* d, double* e, double* tau ); int LAPACKE_dsytrd_work( int matrix_layout, char uplo, int n, double* a, int lda, double* d, double* e, double* tau, double* work, int lwork ); int LAPACKE_dsytrf( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv ); int LAPACKE_dsytrf_rook( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv ); int LAPACKE_dsytrf_rook_work( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv, double* work, int lwork ); int LAPACKE_dsytrf_work( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv, double* work, int lwork ); int LAPACKE_dsytri( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv ); int LAPACKE_dsytri2( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv ); int LAPACKE_dsytri2_work( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, double* work, int lwork ); int LAPACKE_dsytri2x( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, int nb ); int LAPACKE_dsytri2x_work( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, double* work, int nb ); int LAPACKE_dsytri_work( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, double* work ); int LAPACKE_dsytrs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs2( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb, double* work ); int LAPACKE_dsytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dtbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const double* ab, int ldab, double* rcond ); int LAPACKE_dtbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const double* ab, int ldab, double* rcond, double* work, int* iwork ); int LAPACKE_dtbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dtbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dtbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dtbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dtfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, double alpha, const double* a, double* b, int ldb ); int LAPACKE_dtfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, double alpha, const double* a, double* b, int ldb ); int LAPACKE_dtftri( int matrix_layout, char transr, char uplo, char diag, int n, double* a ); int LAPACKE_dtftri_work( int matrix_layout, char transr, char uplo, char diag, int n, double* a ); int LAPACKE_dtfttp( int matrix_layout, char transr, char uplo, int n, const double* arf, double* ap ); int LAPACKE_dtfttp_work( int matrix_layout, char transr, char uplo, int n, const double* arf, double* ap ); int LAPACKE_dtfttr( int matrix_layout, char transr, char uplo, int n, const double* arf, double* a, int lda ); int LAPACKE_dtfttr_work( int matrix_layout, char transr, char uplo, int n, const double* arf, double* a, int lda ); int LAPACKE_dtgevc( int matrix_layout, char side, char howmny, const int* select, int n, const double* s, int lds, const double* p, int ldp, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m ); int LAPACKE_dtgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const double* s, int lds, const double* p, int ldp, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, double* work ); int LAPACKE_dtgexc( int matrix_layout, int wantq, int wantz, int n, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz, int* ifst, int* ilst ); int LAPACKE_dtgexc_work( int matrix_layout, int wantq, int wantz, int n, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz, int* ifst, int* ilst, double* work, int lwork ); int LAPACKE_dtgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz, int* m, double* pl, double* pr, double* dif ); int LAPACKE_dtgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz, int* m, double* pl, double* pr, double* dif, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dtgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, double* a, int lda, double* b, int ldb, double tola, double tolb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* ncycle ); int LAPACKE_dtgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, double* a, int lda, double* b, int ldb, double tola, double tolb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, double* work, int* ncycle ); int LAPACKE_dtgsna( int matrix_layout, char job, char howmny, const int* select, int n, const double* a, int lda, const double* b, int ldb, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* dif, int mm, int* m ); int LAPACKE_dtgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const double* a, int lda, const double* b, int ldb, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* dif, int mm, int* m, double* work, int lwork, int* iwork ); int LAPACKE_dtgsyl( int matrix_layout, char trans, int ijob, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, const double* d, int ldd, const double* e, int lde, double* f, int ldf, double* scale, double* dif ); int LAPACKE_dtgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, const double* d, int ldd, const double* e, int lde, double* f, int ldf, double* scale, double* dif, double* work, int lwork, int* iwork ); int LAPACKE_dtpcon( int matrix_layout, char norm, char uplo, char diag, int n, const double* ap, double* rcond ); int LAPACKE_dtpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const double* ap, double* rcond, double* work, int* iwork ); int LAPACKE_dtpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb ); int LAPACKE_dtpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb, double* work ); int LAPACKE_dtpqrt( int matrix_layout, int m, int n, int l, int nb, double* a, int lda, double* b, int ldb, double* t, int ldt ); int LAPACKE_dtpqrt2( int matrix_layout, int m, int n, int l, double* a, int lda, double* b, int ldb, double* t, int ldt ); int LAPACKE_dtpqrt2_work( int matrix_layout, int m, int n, int l, double* a, int lda, double* b, int ldb, double* t, int ldt ); int LAPACKE_dtpqrt_work( int matrix_layout, int m, int n, int l, int nb, double* a, int lda, double* b, int ldb, double* t, int ldt, double* work ); int LAPACKE_dtprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb ); int LAPACKE_dtprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb, double* work, int ldwork ); int LAPACKE_dtprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dtprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dtptri( int matrix_layout, char uplo, char diag, int n, double* ap ); int LAPACKE_dtptri_work( int matrix_layout, char uplo, char diag, int n, double* ap ); int LAPACKE_dtptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dtptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dtpttf( int matrix_layout, char transr, char uplo, int n, const double* ap, double* arf ); int LAPACKE_dtpttf_work( int matrix_layout, char transr, char uplo, int n, const double* ap, double* arf ); int LAPACKE_dtpttr( int matrix_layout, char uplo, int n, const double* ap, double* a, int lda ); int LAPACKE_dtpttr_work( int matrix_layout, char uplo, int n, const double* ap, double* a, int lda ); int LAPACKE_dtrcon( int matrix_layout, char norm, char uplo, char diag, int n, const double* a, int lda, double* rcond ); int LAPACKE_dtrcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const double* a, int lda, double* rcond, double* work, int* iwork ); int LAPACKE_dtrevc( int matrix_layout, char side, char howmny, int* select, int n, const double* t, int ldt, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m ); int LAPACKE_dtrevc_work( int matrix_layout, char side, char howmny, int* select, int n, const double* t, int ldt, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, double* work ); int LAPACKE_dtrexc( int matrix_layout, char compq, int n, double* t, int ldt, double* q, int ldq, int* ifst, int* ilst ); int LAPACKE_dtrexc_work( int matrix_layout, char compq, int n, double* t, int ldt, double* q, int ldq, int* ifst, int* ilst, double* work ); int LAPACKE_dtrrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dtrrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dtrsen( int matrix_layout, char job, char compq, const int* select, int n, double* t, int ldt, double* q, int ldq, double* wr, double* wi, int* m, double* s, double* sep ); int LAPACKE_dtrsen_work( int matrix_layout, char job, char compq, const int* select, int n, double* t, int ldt, double* q, int ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dtrsna( int matrix_layout, char job, char howmny, const int* select, int n, const double* t, int ldt, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* sep, int mm, int* m ); int LAPACKE_dtrsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const double* t, int ldt, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* sep, int mm, int* m, double* work, int ldwork, int* iwork ); int LAPACKE_dtrsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, double* scale ); int LAPACKE_dtrsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, double* scale ); int LAPACKE_dtrtri( int matrix_layout, char uplo, char diag, int n, double* a, int lda ); int LAPACKE_dtrtri_work( int matrix_layout, char uplo, char diag, int n, double* a, int lda ); int LAPACKE_dtrtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dtrtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dtrttf( int matrix_layout, char transr, char uplo, int n, const double* a, int lda, double* arf ); int LAPACKE_dtrttf_work( int matrix_layout, char transr, char uplo, int n, const double* a, int lda, double* arf ); int LAPACKE_dtrttp( int matrix_layout, char uplo, int n, const double* a, int lda, double* ap ); int LAPACKE_dtrttp_work( int matrix_layout, char uplo, int n, const double* a, int lda, double* ap ); int LAPACKE_dtzrzf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dtzrzf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_mkl_cgetrfnpi( int matrix_layout, int m, int n, int nfact, MKL_Complex8* a, int lda ); int LAPACKE_mkl_cgetrfnpi_work( int matrix_layout, int m, int n, int nfact, MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctppack( int matrix_layout, char uplo, char trans, int n, MKL_Complex8* ap, int i, int j, int rows, int cols, const MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctppack_work( int matrix_layout, char uplo, char trans, int n, MKL_Complex8* ap, int i, int j, int rows, int cols, const MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctpunpack( int matrix_layout, char uplo, char trans, int n, const MKL_Complex8* ap, int i, int j, int rows, int cols, MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctpunpack_work( int matrix_layout, char uplo, char trans, int n, const MKL_Complex8* ap, int i, int j, int rows, int cols, MKL_Complex8* a, int lda ); int LAPACKE_mkl_dgetrfnpi( int matrix_layout, int m, int n, int nfact, double* a, int lda ); int LAPACKE_mkl_dgetrfnpi_work( int matrix_layout, int m, int n, int nfact, double* a, int lda ); int LAPACKE_mkl_dtppack( int matrix_layout, char uplo, char trans, int n, double* ap, int i, int j, int rows, int cols, const double* a, int lda ); int LAPACKE_mkl_dtppack_work( int matrix_layout, char uplo, char trans, int n, double* ap, int i, int j, int rows, int cols, const double* a, int lda ); int LAPACKE_mkl_dtpunpack( int matrix_layout, char uplo, char trans, int n, const double* ap, int i, int j, int rows, int cols, double* a, int lda ); int LAPACKE_mkl_dtpunpack_work( int matrix_layout, char uplo, char trans, int n, const double* ap, int i, int j, int rows, int cols, double* a, int lda ); int LAPACKE_mkl_sgetrfnpi( int matrix_layout, int m, int n, int nfact, float* a, int lda); int LAPACKE_mkl_sgetrfnpi_work( int matrix_layout, int m, int n, int nfact, float* a, int lda ); int LAPACKE_mkl_stppack( int matrix_layout, char uplo, char trans, int n, float* ap, int i, int j, int rows, int cols, const float* a, int lda ); int LAPACKE_mkl_stppack_work( int matrix_layout, char uplo, char trans, int n, float* ap, int i, int j, int rows, int cols, const float* a, int lda ); int LAPACKE_mkl_stpunpack( int matrix_layout, char uplo, char trans, int n, const float* ap, int i, int j, int rows, int cols, float* a, int lda ); int LAPACKE_mkl_stpunpack_work( int matrix_layout, char uplo, char trans, int n, const float* ap, int i, int j, int rows, int cols, float* a, int lda ); int LAPACKE_mkl_zgetrfnpi( int matrix_layout, int m, int n, int nfact, MKL_Complex16* a, int lda ); int LAPACKE_mkl_zgetrfnpi_work( int matrix_layout, int m, int n, int nfact, MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztppack( int matrix_layout, char uplo, char trans, int n, MKL_Complex16* ap, int i, int j, int rows, int cols, const MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztppack_work( int matrix_layout, char uplo, char trans, int n, MKL_Complex16* ap, int i, int j, int rows, int cols, const MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztpunpack( int matrix_layout, char uplo, char trans, int n, const MKL_Complex16* ap, int i, int j, int rows, int cols, MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztpunpack_work( int matrix_layout, char uplo, char trans, int n, const MKL_Complex16* ap, int i, int j, int rows, int cols, MKL_Complex16* a, int lda ); int LAPACKE_sbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e ); int LAPACKE_sbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* work, int lwork ); int LAPACKE_sbdsdc( int matrix_layout, char uplo, char compq, int n, float* d, float* e, float* u, int ldu, float* vt, int ldvt, float* q, int* iq ); int LAPACKE_sbdsdc_work( int matrix_layout, char uplo, char compq, int n, float* d, float* e, float* u, int ldu, float* vt, int ldvt, float* q, int* iq, float* work, int* iwork ); int LAPACKE_sbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, float* vt, int ldvt, float* u, int ldu, float* c, int ldc ); int LAPACKE_sbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, float* vt, int ldvt, float* u, int ldu, float* c, int ldc, float* work ); int LAPACKE_sbdsvdx( int matrix_layout, char uplo, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* ns, float* s, float* z, int ldz, int* superb ); int LAPACKE_sbdsvdx_work( int matrix_layout, char uplo, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* ns, float* s, float* z, int ldz, float* work, int* iwork ); int LAPACKE_sdisna( char job, int m, int n, const float* d, float* sep ); int LAPACKE_sdisna_work( char job, int m, int n, const float* d, float* sep ); int LAPACKE_sgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, float* ab, int ldab, float* d, float* e, float* q, int ldq, float* pt, int ldpt, float* c, int ldc ); int LAPACKE_sgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, float* ab, int ldab, float* d, float* e, float* q, int ldq, float* pt, int ldpt, float* c, int ldc, float* work ); int LAPACKE_sgbcon( int matrix_layout, char norm, int n, int kl, int ku, const float* ab, int ldab, const int* ipiv, float anorm, float* rcond ); int LAPACKE_sgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const float* ab, int ldab, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sgbequ( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbequb( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, float* ab, int ldab, int* ipiv, float* b, int ldb ); int LAPACKE_sgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, float* ab, int ldab, int* ipiv, float* b, int ldb ); int LAPACKE_sgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_sgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgbtrf( int matrix_layout, int m, int n, int kl, int ku, float* ab, int ldab, int* ipiv ); int LAPACKE_sgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, float* ab, int ldab, int* ipiv ); int LAPACKE_sgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const int* ipiv, float* b, int ldb ); int LAPACKE_sgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const int* ipiv, float* b, int ldb ); int LAPACKE_sgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, float* v, int ldv ); int LAPACKE_sgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, float* v, int ldv ); int LAPACKE_sgebal( int matrix_layout, char job, int n, float* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_sgebal_work( int matrix_layout, char job, int n, float* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_sgebrd( int matrix_layout, int m, int n, float* a, int lda, float* d, float* e, float* tauq, float* taup ); int LAPACKE_sgebrd_work( int matrix_layout, int m, int n, float* a, int lda, float* d, float* e, float* tauq, float* taup, float* work, int lwork ); int LAPACKE_sgecon( int matrix_layout, char norm, int n, const float* a, int lda, float anorm, float* rcond ); int LAPACKE_sgecon_work( int matrix_layout, char norm, int n, const float* a, int lda, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sgeequ( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgeequ_work( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgeequb( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgeequb_work( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgees( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs ); int LAPACKE_sgees_work( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs, float* work, int lwork, int* bwork ); int LAPACKE_sgeesx( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, char sense, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs, float* rconde, float* rcondv ); int LAPACKE_sgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, char sense, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs, float* rconde, float* rcondv, float* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_sgeev( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr ); int LAPACKE_sgeev_work( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr, float* work, int lwork ); int LAPACKE_sgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv ); int LAPACKE_sgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, int lwork, int* iwork ); int LAPACKE_sgehrd( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, float* tau ); int LAPACKE_sgehrd_work( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, float* a, int lda, float* sva, float* u, int ldu, float* v, int ldv, float* stat, int* istat ); int LAPACKE_sgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, float* a, int lda, float* sva, float* u, int ldu, float* v, int ldv, float* work, int lwork, int* iwork ); int LAPACKE_sgelq2( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgelq2_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work ); int LAPACKE_sgelqf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgelqf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgels( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sgels_work( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* work, int lwork ); int LAPACKE_sgelsd( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_sgelsd_work( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank, float* work, int lwork, int* iwork ); int LAPACKE_sgelss( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_sgelss_work( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank, float* work, int lwork ); int LAPACKE_sgelsy( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, int* jpvt, float rcond, int* rank ); int LAPACKE_sgelsy_work( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, int* jpvt, float rcond, int* rank, float* work, int lwork ); int LAPACKE_sgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const float* v, int ldv, const float* t, int ldt, float* c, int ldc ); int LAPACKE_sgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const float* v, int ldv, const float* t, int ldt, float* c, int ldc, float* work ); int LAPACKE_sgeqlf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqlf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgeqp3( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau ); int LAPACKE_sgeqp3_work( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau, float* work, int lwork ); int LAPACKE_sgeqpf( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau ); int LAPACKE_sgeqpf_work( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau, float* work ); int LAPACKE_sgeqr2( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqr2_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work ); int LAPACKE_sgeqrf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqrf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgeqrfp( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqrfp_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgeqrt( int matrix_layout, int m, int n, int nb, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt2( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt2_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt3( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt3_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt_work( int matrix_layout, int m, int n, int nb, float* a, int lda, float* t, int ldt, float* work ); int LAPACKE_sgerfs( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sgerfs_work( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgerqf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgerqf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgesdd( int matrix_layout, char jobz, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt ); int LAPACKE_sgesdd_work( int matrix_layout, char jobz, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt, float* work, int lwork, int* iwork ); int LAPACKE_sgesv( int matrix_layout, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_sgesv_work( int matrix_layout, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_sgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt, float* superb ); int LAPACKE_sgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt, float* work, int lwork ); int LAPACKE_sgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, float* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, float* u, int ldu, float* vt, int ldvt, int* superb ); int LAPACKE_sgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, float* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, float* u, int ldu, float* vt, int ldvt, float* work, int lwork, int* iwork ); int LAPACKE_sgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, float* a, int lda, float* sva, int mv, float* v, int ldv, float* stat ); int LAPACKE_sgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, float* a, int lda, float* sva, int mv, float* v, int ldv, float* work, int lwork ); int LAPACKE_sgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_sgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgetf2( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetf2_work( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf2( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf2_work( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf_work( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetri( int matrix_layout, int n, float* a, int lda, const int* ipiv ); int LAPACKE_sgetri_work( int matrix_layout, int n, float* a, int lda, const int* ipiv, float* work, int lwork ); int LAPACKE_sgetrs( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_sgetrs_work( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_sggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, float* v, int ldv ); int LAPACKE_sggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, float* v, int ldv ); int LAPACKE_sggbal( int matrix_layout, char job, int n, float* a, int lda, float* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale ); int LAPACKE_sggbal_work( int matrix_layout, char job, int n, float* a, int lda, float* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work ); int LAPACKE_sgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr ); int LAPACKE_sgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr ); int LAPACKE_sgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* work, int lwork, int* bwork ); int LAPACKE_sgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* work, int lwork, int* bwork ); int LAPACKE_sggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, char sense, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* rconde, float* rcondv ); int LAPACKE_sggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, char sense, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* rconde, float* rcondv, float* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_sggev( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr ); int LAPACKE_sggev3( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr ); int LAPACKE_sggev3_work( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, float* work, int lwork ); int LAPACKE_sggev_work( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, float* work, int lwork ); int LAPACKE_sggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv ); int LAPACKE_sggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, int lwork, int* iwork, int* bwork ); int LAPACKE_sggglm( int matrix_layout, int n, int m, int p, float* a, int lda, float* b, int ldb, float* d, float* x, float* y ); int LAPACKE_sggglm_work( int matrix_layout, int n, int m, int p, float* a, int lda, float* b, int ldb, float* d, float* x, float* y, float* work, int lwork ); int LAPACKE_sgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz ); int LAPACKE_sgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz, float* work, int lwork ); int LAPACKE_sgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz ); int LAPACKE_sgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz ); int LAPACKE_sgglse( int matrix_layout, int m, int n, int p, float* a, int lda, float* b, int ldb, float* c, float* d, float* x ); int LAPACKE_sgglse_work( int matrix_layout, int m, int n, int p, float* a, int lda, float* b, int ldb, float* c, float* d, float* x, float* work, int lwork ); int LAPACKE_sggqrf( int matrix_layout, int n, int m, int p, float* a, int lda, float* taua, float* b, int ldb, float* taub ); int LAPACKE_sggqrf_work( int matrix_layout, int n, int m, int p, float* a, int lda, float* taua, float* b, int ldb, float* taub, float* work, int lwork ); int LAPACKE_sggrqf( int matrix_layout, int m, int p, int n, float* a, int lda, float* taua, float* b, int ldb, float* taub ); int LAPACKE_sggrqf_work( int matrix_layout, int m, int p, int n, float* a, int lda, float* taua, float* b, int ldb, float* taub, float* work, int lwork ); int LAPACKE_sggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork ); int LAPACKE_sggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork ); int LAPACKE_sggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, float* work, int lwork, int* iwork ); int LAPACKE_sggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, float* work, int* iwork ); int LAPACKE_sggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq ); int LAPACKE_sggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq ); int LAPACKE_sggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork, float* tau, float* work, int lwork ); int LAPACKE_sggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork, float* tau, float* work ); int LAPACKE_sgtcon( char norm, int n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float anorm, float* rcond ); int LAPACKE_sgtcon_work( char norm, int n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sgtrfs( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgtsv( int matrix_layout, int n, int nrhs, float* dl, float* d, float* du, float* b, int ldb ); int LAPACKE_sgtsv_work( int matrix_layout, int n, int nrhs, float* dl, float* d, float* du, float* b, int ldb ); int LAPACKE_sgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgttrf( int n, float* dl, float* d, float* du, float* du2, int* ipiv ); int LAPACKE_sgttrf_work( int n, float* dl, float* d, float* du, float* du2, int* ipiv ); int LAPACKE_sgttrs( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, int ldb ); int LAPACKE_sgttrs_work( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, int ldb ); int LAPACKE_shgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, float* h, int ldh, float* t, int ldt, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz ); int LAPACKE_shgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, float* h, int ldh, float* t, int ldt, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz, float* work, int lwork ); int LAPACKE_shsein( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const float* h, int ldh, float* wr, const float* wi, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_shsein_work( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const float* h, int ldh, float* wr, const float* wi, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, float* work, int* ifaill, int* ifailr ); int LAPACKE_shseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, float* h, int ldh, float* wr, float* wi, float* z, int ldz ); int LAPACKE_shseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, float* h, int ldh, float* wr, float* wi, float* z, int ldz, float* work, int lwork ); int LAPACKE_slacn2( int n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); int LAPACKE_slacn2_work( int n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); int LAPACKE_slacpy( int matrix_layout, char uplo, int m, int n, const float* a, int lda, float* b, int ldb ); int LAPACKE_slacpy_work( int matrix_layout, char uplo, int m, int n, const float* a, int lda, float* b, int ldb ); int LAPACKE_slag2d( int matrix_layout, int m, int n, const float* sa, int ldsa, double* a, int lda ); int LAPACKE_slag2d_work( int matrix_layout, int m, int n, const float* sa, int ldsa, double* a, int lda ); int LAPACKE_slagge( int matrix_layout, int m, int n, int kl, int ku, const float* d, float* a, int lda, int* iseed ); int LAPACKE_slagge_work( int matrix_layout, int m, int n, int kl, int ku, const float* d, float* a, int lda, int* iseed, float* work ); int LAPACKE_slagsy( int matrix_layout, int n, int k, const float* d, float* a, int lda, int* iseed ); int LAPACKE_slagsy_work( int matrix_layout, int n, int k, const float* d, float* a, int lda, int* iseed, float* work ); int LAPACKE_slapmr( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slapmr_work( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slapmt( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slapmt_work( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const float* v, int ldv, const float* t, int ldt, float* c, int ldc ); int LAPACKE_slarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const float* v, int ldv, const float* t, int ldt, float* c, int ldc, float* work, int ldwork ); int LAPACKE_slarfg( int n, float* alpha, float* x, int incx, float* tau ); int LAPACKE_slarfg_work( int n, float* alpha, float* x, int incx, float* tau ); int LAPACKE_slarft( int matrix_layout, char direct, char storev, int n, int k, const float* v, int ldv, const float* tau, float* t, int ldt ); int LAPACKE_slarft_work( int matrix_layout, char direct, char storev, int n, int k, const float* v, int ldv, const float* tau, float* t, int ldt ); int LAPACKE_slarfx( int matrix_layout, char side, int m, int n, const float* v, float tau, float* c, int ldc, float* work ); int LAPACKE_slarfx_work( int matrix_layout, char side, int m, int n, const float* v, float tau, float* c, int ldc, float* work ); int LAPACKE_slarnv( int idist, int* iseed, int n, float* x ); int LAPACKE_slarnv_work( int idist, int* iseed, int n, float* x ); int LAPACKE_slartgp( float f, float g, float* cs, float* sn, float* r ); int LAPACKE_slartgp_work( float f, float g, float* cs, float* sn, float* r ); int LAPACKE_slartgs( float x, float y, float sigma, float* cs, float* sn ); int LAPACKE_slartgs_work( float x, float y, float sigma, float* cs, float* sn ); int LAPACKE_slascl( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, float* a, int lda ); int LAPACKE_slascl_work( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, float* a, int lda ); int LAPACKE_slaset( int matrix_layout, char uplo, int m, int n, float alpha, float beta, float* a, int lda ); int LAPACKE_slaset_work( int matrix_layout, char uplo, int m, int n, float alpha, float beta, float* a, int lda ); int LAPACKE_slasrt( char id, int n, float* d ); int LAPACKE_slasrt_work( char id, int n, float* d ); int LAPACKE_slaswp( int matrix_layout, int n, float* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_slaswp_work( int matrix_layout, int n, float* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_slatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, float* a, int lda ); int LAPACKE_slatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, float* a, int lda, float* work ); int LAPACKE_slauum( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_slauum_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_sopgtr( int matrix_layout, char uplo, int n, const float* ap, const float* tau, float* q, int ldq ); int LAPACKE_sopgtr_work( int matrix_layout, char uplo, int n, const float* ap, const float* tau, float* q, int ldq, float* work ); int LAPACKE_sopmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* ap, const float* tau, float* c, int ldc ); int LAPACKE_sopmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* ap, const float* tau, float* c, int ldc, float* work ); int LAPACKE_sorbdb( int matrix_layout, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2 ); int LAPACKE_sorbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, int lwork ); int LAPACKE_sorcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t ); int LAPACKE_sorcsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, float* x11, int ldx11, float* x21, int ldx21, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t ); int LAPACKE_sorcsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, float* x11, int ldx11, float* x21, int ldx21, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* work, int lwork, int* iwork ); int LAPACKE_sorcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t, float* work, int lwork, int* iwork ); int LAPACKE_sorgbr( int matrix_layout, char vect, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgbr_work( int matrix_layout, char vect, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorghr( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, const float* tau ); int LAPACKE_sorghr_work( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorglq( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorglq_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgql( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgql_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgqr( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgqr_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgrq( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgrq_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgtr( int matrix_layout, char uplo, int n, float* a, int lda, const float* tau ); int LAPACKE_sorgtr_work( int matrix_layout, char uplo, int n, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sormbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormlq( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormql( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormql_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormqr( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormrq( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_spbcon( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float anorm, float* rcond ); int LAPACKE_spbcon_work( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_spbequ( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_spbequ_work( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_spbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_spbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_spbstf( int matrix_layout, char uplo, int n, int kb, float* bb, int ldbb ); int LAPACKE_spbstf_work( int matrix_layout, char uplo, int n, int kb, float* bb, int ldbb ); int LAPACKE_spbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* b, int ldb ); int LAPACKE_spbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* b, int ldb ); int LAPACKE_spbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* afb, int ldafb, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_spbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* afb, int ldafb, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_spbtrf( int matrix_layout, char uplo, int n, int kd, float* ab, int ldab ); int LAPACKE_spbtrf_work( int matrix_layout, char uplo, int n, int kd, float* ab, int ldab ); int LAPACKE_spbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_spbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_spftrf( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftrf_work( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftri( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftri_work( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const float* a, float* b, int ldb ); int LAPACKE_spftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const float* a, float* b, int ldb ); int LAPACKE_spocon( int matrix_layout, char uplo, int n, const float* a, int lda, float anorm, float* rcond ); int LAPACKE_spocon_work( int matrix_layout, char uplo, int n, const float* a, int lda, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_spoequ( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_spoequ_work( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_spoequb( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_spoequb_work( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_sporfs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sporfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sposv( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sposv_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_spotrf( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrf2( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrf2_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrf_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotri( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotri_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_spotrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_sppcon( int matrix_layout, char uplo, int n, const float* ap, float anorm, float* rcond ); int LAPACKE_sppcon_work( int matrix_layout, char uplo, int n, const float* ap, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sppequ( int matrix_layout, char uplo, int n, const float* ap, float* s, float* scond, float* amax ); int LAPACKE_sppequ_work( int matrix_layout, char uplo, int n, const float* ap, float* s, float* scond, float* amax ); int LAPACKE_spprfs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_spprfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sppsv( int matrix_layout, char uplo, int n, int nrhs, float* ap, float* b, int ldb ); int LAPACKE_sppsv_work( int matrix_layout, char uplo, int n, int nrhs, float* ap, float* b, int ldb ); int LAPACKE_sppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* ap, float* afp, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* ap, float* afp, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_spptrf( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptrf_work( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptri( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptri_work( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptrs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_spptrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_spstrf( int matrix_layout, char uplo, int n, float* a, int lda, int* piv, int* rank, float tol ); int LAPACKE_spstrf_work( int matrix_layout, char uplo, int n, float* a, int lda, int* piv, int* rank, float tol, float* work ); int LAPACKE_sptcon( int n, const float* d, const float* e, float anorm, float* rcond ); int LAPACKE_sptcon_work( int n, const float* d, const float* e, float anorm, float* rcond, float* work ); int LAPACKE_spteqr( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_spteqr_work( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz, float* work ); int LAPACKE_sptrfs( int matrix_layout, int n, int nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sptrfs_work( int matrix_layout, int n, int nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work ); int LAPACKE_sptsv( int matrix_layout, int n, int nrhs, float* d, float* e, float* b, int ldb ); int LAPACKE_sptsv_work( int matrix_layout, int n, int nrhs, float* d, float* e, float* b, int ldb ); int LAPACKE_sptsvx( int matrix_layout, char fact, int n, int nrhs, const float* d, const float* e, float* df, float* ef, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sptsvx_work( int matrix_layout, char fact, int n, int nrhs, const float* d, const float* e, float* df, float* ef, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work ); int LAPACKE_spttrf( int n, float* d, float* e ); int LAPACKE_spttrf_work( int n, float* d, float* e ); int LAPACKE_spttrs( int matrix_layout, int n, int nrhs, const float* d, const float* e, float* b, int ldb ); int LAPACKE_spttrs_work( int matrix_layout, int n, int nrhs, const float* d, const float* e, float* b, int ldb ); int LAPACKE_ssbev( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work ); int LAPACKE_ssbevd( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, float* ab, int ldab, const float* bb, int ldbb, float* x, int ldx ); int LAPACKE_ssbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, float* ab, int ldab, const float* bb, int ldbb, float* x, int ldx, float* work ); int LAPACKE_ssbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz ); int LAPACKE_ssbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz, float* work ); int LAPACKE_ssbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz ); int LAPACKE_ssbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssbtrd( int matrix_layout, char vect, char uplo, int n, int kd, float* ab, int ldab, float* d, float* e, float* q, int ldq ); int LAPACKE_ssbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, float* ab, int ldab, float* d, float* e, float* q, int ldq, float* work ); int LAPACKE_ssfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const float* a, int lda, float beta, float* c ); int LAPACKE_ssfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const float* a, int lda, float beta, float* c ); int LAPACKE_sspcon( int matrix_layout, char uplo, int n, const float* ap, const int* ipiv, float anorm, float* rcond ); int LAPACKE_sspcon_work( int matrix_layout, char uplo, int n, const float* ap, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sspev( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz ); int LAPACKE_sspev_work( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz, float* work ); int LAPACKE_sspevd( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz ); int LAPACKE_sspevd_work( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sspevx( int matrix_layout, char jobz, char range, char uplo, int n, float* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_sspevx_work( int matrix_layout, char jobz, char range, char uplo, int n, float* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_sspgst( int matrix_layout, int itype, char uplo, int n, float* ap, const float* bp ); int LAPACKE_sspgst_work( int matrix_layout, int itype, char uplo, int n, float* ap, const float* bp ); int LAPACKE_sspgv( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz ); int LAPACKE_sspgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz, float* work ); int LAPACKE_sspgvd( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz ); int LAPACKE_sspgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sspgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* ap, float* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_sspgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* ap, float* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssprfs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_ssprfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sspsv( int matrix_layout, char uplo, int n, int nrhs, float* ap, int* ipiv, float* b, int ldb ); int LAPACKE_sspsv_work( int matrix_layout, char uplo, int n, int nrhs, float* ap, int* ipiv, float* b, int ldb ); int LAPACKE_sspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* ap, float* afp, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* ap, float* afp, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_ssptrd( int matrix_layout, char uplo, int n, float* ap, float* d, float* e, float* tau ); int LAPACKE_ssptrd_work( int matrix_layout, char uplo, int n, float* ap, float* d, float* e, float* tau ); int LAPACKE_ssptrf( int matrix_layout, char uplo, int n, float* ap, int* ipiv ); int LAPACKE_ssptrf_work( int matrix_layout, char uplo, int n, float* ap, int* ipiv ); int LAPACKE_ssptri( int matrix_layout, char uplo, int n, float* ap, const int* ipiv ); int LAPACKE_ssptri_work( int matrix_layout, char uplo, int n, float* ap, const int* ipiv, float* work ); int LAPACKE_ssptrs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const int* ipiv, float* b, int ldb ); int LAPACKE_ssptrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const int* ipiv, float* b, int ldb ); int LAPACKE_sstebz( char range, char order, int n, float vl, float vu, int il, int iu, float abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit ); int LAPACKE_sstebz_work( char range, char order, int n, float vl, float vu, int il, int iu, float abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork ); int LAPACKE_sstedc( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_sstedc_work( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstegr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_sstegr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstein( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, float* z, int ldz, int* ifailv ); int LAPACKE_sstein_work( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, float* z, int ldz, float* work, int* iwork, int* ifailv ); int LAPACKE_sstemr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, float* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_sstemr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, float* z, int ldz, int nzc, int* isuppz, int* tryrac, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssteqr( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_ssteqr_work( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz, float* work ); int LAPACKE_ssterf( int n, float* d, float* e ); int LAPACKE_ssterf_work( int n, float* d, float* e ); int LAPACKE_sstev( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_sstev_work( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz, float* work ); int LAPACKE_sstevd( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_sstevd_work( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstevr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_sstevr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstevx( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_sstevx_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssycon( int matrix_layout, char uplo, int n, const float* a, int lda, const int* ipiv, float anorm, float* rcond ); int LAPACKE_ssycon_work( int matrix_layout, char uplo, int n, const float* a, int lda, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_ssyconv( int matrix_layout, char uplo, char way, int n, float* a, int lda, const int* ipiv, float* e ); int LAPACKE_ssyconv_work( int matrix_layout, char uplo, char way, int n, float* a, int lda, const int* ipiv, float* e ); int LAPACKE_ssyequb( int matrix_layout, char uplo, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_ssyequb_work( int matrix_layout, char uplo, int n, const float* a, int lda, float* s, float* scond, float* amax, float* work ); int LAPACKE_ssyev( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyev_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork ); int LAPACKE_ssyevd( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyevd_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevr( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_ssyevr_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevx( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssyevx_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssygst( int matrix_layout, int itype, char uplo, int n, float* a, int lda, const float* b, int ldb ); int LAPACKE_ssygst_work( int matrix_layout, int itype, char uplo, int n, float* a, int lda, const float* b, int ldb ); int LAPACKE_ssygv( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w ); int LAPACKE_ssygv_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w, float* work, int lwork ); int LAPACKE_ssygvd( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w ); int LAPACKE_ssygvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssygvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* a, int lda, float* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssygvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* a, int lda, float* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssyrfs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_ssyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_ssyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_ssyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_ssysv( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_rook( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssysv_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* a, int lda, float* af, int ldaf, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_ssysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* a, int lda, float* af, int ldaf, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int lwork, int* iwork ); int LAPACKE_ssysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_ssysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_ssyswapr( int matrix_layout, char uplo, int n, float* a, int lda, int i1, int i2 ); int LAPACKE_ssyswapr_work( int matrix_layout, char uplo, int n, float* a, int lda, int i1, int i2 ); int LAPACKE_ssytrd( int matrix_layout, char uplo, int n, float* a, int lda, float* d, float* e, float* tau ); int LAPACKE_ssytrd_work( int matrix_layout, char uplo, int n, float* a, int lda, float* d, float* e, float* tau, float* work, int lwork ); int LAPACKE_ssytrf( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv ); int LAPACKE_ssytrf_rook( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv ); int LAPACKE_ssytrf_rook_work( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv, float* work, int lwork ); int LAPACKE_ssytrf_work( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv, float* work, int lwork ); int LAPACKE_ssytri( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv ); int LAPACKE_ssytri2( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv ); int LAPACKE_ssytri2_work( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, float* work, int lwork ); int LAPACKE_ssytri2x( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, int nb ); int LAPACKE_ssytri2x_work( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, float* work, int nb ); int LAPACKE_ssytri_work( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, float* work ); int LAPACKE_ssytrs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs2( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb, float* work ); int LAPACKE_ssytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_stbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const float* ab, int ldab, float* rcond ); int LAPACKE_stbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const float* ab, int ldab, float* rcond, float* work, int* iwork ); int LAPACKE_stbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr ); int LAPACKE_stbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_stbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_stbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_stfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, float alpha, const float* a, float* b, int ldb ); int LAPACKE_stfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, float alpha, const float* a, float* b, int ldb ); int LAPACKE_stftri( int matrix_layout, char transr, char uplo, char diag, int n, float* a ); int LAPACKE_stftri_work( int matrix_layout, char transr, char uplo, char diag, int n, float* a ); int LAPACKE_stfttp( int matrix_layout, char transr, char uplo, int n, const float* arf, float* ap ); int LAPACKE_stfttp_work( int matrix_layout, char transr, char uplo, int n, const float* arf, float* ap ); int LAPACKE_stfttr( int matrix_layout, char transr, char uplo, int n, const float* arf, float* a, int lda ); int LAPACKE_stfttr_work( int matrix_layout, char transr, char uplo, int n, const float* arf, float* a, int lda ); int LAPACKE_stgevc( int matrix_layout, char side, char howmny, const int* select, int n, const float* s, int lds, const float* p, int ldp, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m ); int LAPACKE_stgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const float* s, int lds, const float* p, int ldp, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, float* work ); int LAPACKE_stgexc( int matrix_layout, int wantq, int wantz, int n, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz, int* ifst, int* ilst ); int LAPACKE_stgexc_work( int matrix_layout, int wantq, int wantz, int n, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz, int* ifst, int* ilst, float* work, int lwork ); int LAPACKE_stgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz, int* m, float* pl, float* pr, float* dif ); int LAPACKE_stgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz, int* m, float* pl, float* pr, float* dif, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_stgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, float* a, int lda, float* b, int ldb, float tola, float tolb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* ncycle ); int LAPACKE_stgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, float* a, int lda, float* b, int ldb, float tola, float tolb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, float* work, int* ncycle ); int LAPACKE_stgsna( int matrix_layout, char job, char howmny, const int* select, int n, const float* a, int lda, const float* b, int ldb, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* dif, int mm, int* m ); int LAPACKE_stgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const float* a, int lda, const float* b, int ldb, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* dif, int mm, int* m, float* work, int lwork, int* iwork ); int LAPACKE_stgsyl( int matrix_layout, char trans, int ijob, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, const float* d, int ldd, const float* e, int lde, float* f, int ldf, float* scale, float* dif ); int LAPACKE_stgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, const float* d, int ldd, const float* e, int lde, float* f, int ldf, float* scale, float* dif, float* work, int lwork, int* iwork ); int LAPACKE_stpcon( int matrix_layout, char norm, char uplo, char diag, int n, const float* ap, float* rcond ); int LAPACKE_stpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const float* ap, float* rcond, float* work, int* iwork ); int LAPACKE_stpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb ); int LAPACKE_stpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb, float* work ); int LAPACKE_stpqrt( int matrix_layout, int m, int n, int l, int nb, float* a, int lda, float* b, int ldb, float* t, int ldt ); int LAPACKE_stpqrt2( int matrix_layout, int m, int n, int l, float* a, int lda, float* b, int ldb, float* t, int ldt ); int LAPACKE_stpqrt2_work( int matrix_layout, int m, int n, int l, float* a, int lda, float* b, int ldb, float* t, int ldt ); int LAPACKE_stpqrt_work( int matrix_layout, int m, int n, int l, int nb, float* a, int lda, float* b, int ldb, float* t, int ldt, float* work ); int LAPACKE_stprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb); int LAPACKE_stprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb, float* work, int ldwork ); int LAPACKE_stprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr ); int LAPACKE_stprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_stptri( int matrix_layout, char uplo, char diag, int n, float* ap ); int LAPACKE_stptri_work( int matrix_layout, char uplo, char diag, int n, float* ap ); int LAPACKE_stptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_stptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_stpttf( int matrix_layout, char transr, char uplo, int n, const float* ap, float* arf ); int LAPACKE_stpttf_work( int matrix_layout, char transr, char uplo, int n, const float* ap, float* arf ); int LAPACKE_stpttr( int matrix_layout, char uplo, int n, const float* ap, float* a, int lda ); int LAPACKE_stpttr_work( int matrix_layout, char uplo, int n, const float* ap, float* a, int lda ); int LAPACKE_strcon( int matrix_layout, char norm, char uplo, char diag, int n, const float* a, int lda, float* rcond ); int LAPACKE_strcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const float* a, int lda, float* rcond, float* work, int* iwork ); int LAPACKE_strevc( int matrix_layout, char side, char howmny, int* select, int n, const float* t, int ldt, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m ); int LAPACKE_strevc_work( int matrix_layout, char side, char howmny, int* select, int n, const float* t, int ldt, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, float* work ); int LAPACKE_strexc( int matrix_layout, char compq, int n, float* t, int ldt, float* q, int ldq, int* ifst, int* ilst ); int LAPACKE_strexc_work( int matrix_layout, char compq, int n, float* t, int ldt, float* q, int ldq, int* ifst, int* ilst, float* work ); int LAPACKE_strrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr ); int LAPACKE_strrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_strsen( int matrix_layout, char job, char compq, const int* select, int n, float* t, int ldt, float* q, int ldq, float* wr, float* wi, int* m, float* s, float* sep ); int LAPACKE_strsen_work( int matrix_layout, char job, char compq, const int* select, int n, float* t, int ldt, float* q, int ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_strsna( int matrix_layout, char job, char howmny, const int* select, int n, const float* t, int ldt, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* sep, int mm, int* m ); int LAPACKE_strsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const float* t, int ldt, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* sep, int mm, int* m, float* work, int ldwork, int* iwork ); int LAPACKE_strsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, float* scale ); int LAPACKE_strsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, float* scale ); int LAPACKE_strtri( int matrix_layout, char uplo, char diag, int n, float* a, int lda ); int LAPACKE_strtri_work( int matrix_layout, char uplo, char diag, int n, float* a, int lda ); int LAPACKE_strtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_strtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_strttf( int matrix_layout, char transr, char uplo, int n, const float* a, int lda, float* arf ); int LAPACKE_strttf_work( int matrix_layout, char transr, char uplo, int n, const float* a, int lda, float* arf ); int LAPACKE_strttp( int matrix_layout, char uplo, int n, const float* a, int lda, float* ap ); int LAPACKE_strttp_work( int matrix_layout, char uplo, int n, const float* a, int lda, float* ap ); int LAPACKE_stzrzf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_stzrzf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_zbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e ); int LAPACKE_zbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, int lrwork ); int LAPACKE_zbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, MKL_Complex16* vt, int ldvt, MKL_Complex16* u, int ldu, MKL_Complex16* c, int ldc ); int LAPACKE_zbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, MKL_Complex16* vt, int ldvt, MKL_Complex16* u, int ldu, MKL_Complex16* c, int ldc, double* work ); int LAPACKE_zcgesv( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, int* iter ); int LAPACKE_zcgesv_work( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter ); int LAPACKE_zcposv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, int* iter ); int LAPACKE_zcposv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter ); int LAPACKE_zgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq, MKL_Complex16* pt, int ldpt, MKL_Complex16* c, int ldc ); int LAPACKE_zgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq, MKL_Complex16* pt, int ldpt, MKL_Complex16* c, int ldc, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbcon( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbequ( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbequb( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_zgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbtrf( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex16* ab, int ldab, int* ipiv ); int LAPACKE_zgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex16* ab, int ldab, int* ipiv ); int LAPACKE_zgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zgebal( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_zgebal_work( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_zgebrd( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup ); int LAPACKE_zgebrd_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int lwork ); int LAPACKE_zgecon( int matrix_layout, char norm, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond ); int LAPACKE_zgecon_work( int matrix_layout, char norm, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zgeequ( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgeequ_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgeequb( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgeequb_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgees( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs ); int LAPACKE_zgees_work( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zgeesx( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, char sense, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs, double* rconde, double* rcondv ); int LAPACKE_zgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, char sense, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zgeev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr ); int LAPACKE_zgeev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv ); int LAPACKE_zgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgehrd( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgehrd_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex16* a, int lda, double* sva, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, double* stat, int* istat ); int LAPACKE_zgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex16* a, int lda, double* sva, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* cwork, int lwork, double* rwork, int lrwork, int* iwork ); int LAPACKE_zgelq2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgelq2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work ); int LAPACKE_zgelqf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgelqf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgels( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zgels_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zgelsd( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_zgelsd_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zgelss( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_zgelss_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgelsy( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* jpvt, double rcond, int* rank ); int LAPACKE_zgelsy_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* jpvt, double rcond, int* rank, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc ); int LAPACKE_zgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc, MKL_Complex16* work ); int LAPACKE_zgeqlf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqlf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqp3( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau ); int LAPACKE_zgeqp3_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgeqpf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau ); int LAPACKE_zgeqpf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork ); int LAPACKE_zgeqr2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqr2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work ); int LAPACKE_zgeqrf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqrf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqrfp( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqrfp_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqrt( int matrix_layout, int m, int n, int nb, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt3( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt3_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt_work( int matrix_layout, int m, int n, int nb, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt, MKL_Complex16* work ); int LAPACKE_zgerfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zgerfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgerqf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgerqf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgesdd( int matrix_layout, char jobz, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt ); int LAPACKE_zgesdd_work( int matrix_layout, char jobz, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zgesv( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgesv_work( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, double* superb ); int LAPACKE_zgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, int* ns, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, int* superb ); int LAPACKE_zgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, int* ns, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex16 * a, int lda, double* sva, int mv, MKL_Complex16* v, int ldv, double* stat ); int LAPACKE_zgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex16* a, int lda, double* sva, int mv, MKL_Complex16* v, int ldv, MKL_Complex16* cwork, int lwork, double* rwork, int lrwork ); int LAPACKE_zgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_zgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgetf2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetf2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetri( int matrix_layout, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zgetri_work( int matrix_layout, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zgetrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgetrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zggbal( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale ); int LAPACKE_zggbal_work( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work ); int LAPACKE_zgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr ); int LAPACKE_zgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr ); int LAPACKE_zgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, double* rconde, double* rcondv ); int LAPACKE_zggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int liwork, int* bwork ); int LAPACKE_zggev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr ); int LAPACKE_zggev3( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr ); int LAPACKE_zggev3_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zggev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv ); int LAPACKE_zggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* bwork ); int LAPACKE_zggglm( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y ); int LAPACKE_zggglm_work( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, int lwork ); int LAPACKE_zgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork ); int LAPACKE_zgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zgglse( int matrix_layout, int m, int n, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x ); int LAPACKE_zgglse_work( int matrix_layout, int m, int n, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, int lwork ); int LAPACKE_zggqrf( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub ); int LAPACKE_zggqrf_work( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub, MKL_Complex16* work, int lwork ); int LAPACKE_zggrqf( int matrix_layout, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub ); int LAPACKE_zggrqf_work( int matrix_layout, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub, MKL_Complex16* work, int lwork ); int LAPACKE_zggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork ); int LAPACKE_zggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork ); int LAPACKE_zggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, MKL_Complex16* work, double* rwork, int* iwork ); int LAPACKE_zggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq ); int LAPACKE_zggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq ); int LAPACKE_zggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work ); int LAPACKE_zgtcon( char norm, int n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zgtcon_work( char norm, int n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zgtrfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgtsv( int matrix_layout, int n, int nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, int ldb ); int LAPACKE_zgtsv_work( int matrix_layout, int n, int nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, int ldb ); int LAPACKE_zgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgttrf( int n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv ); int LAPACKE_zgttrf_work( int n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv ); int LAPACKE_zgttrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgttrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhbev( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhbevd( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, const MKL_Complex16* bb, int ldbb, MKL_Complex16* x, int ldx ); int LAPACKE_zhbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, const MKL_Complex16* bb, int ldbb, MKL_Complex16* x, int ldx, MKL_Complex16* work, double* rwork ); int LAPACKE_zhbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhbtrd( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq ); int LAPACKE_zhbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq, MKL_Complex16* work ); int LAPACKE_zhecon( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zhecon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zheequb( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zheequb_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax, MKL_Complex16* work ); int LAPACKE_zheev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zheevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevr( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz ); int LAPACKE_zheevr_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zheevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhegst( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb ); int LAPACKE_zhegst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb ); int LAPACKE_zhegv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w ); int LAPACKE_zhegv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhegvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w ); int LAPACKE_zhegvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhegvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhegvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zherfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zherfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zherfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zherfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zhesv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhesv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zhesvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zhesvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhesvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zhesvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zheswapr( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zheswapr_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zhetrd( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tau ); int LAPACKE_zhetrd_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zhetrf_rook( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zhetrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetri( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zhetri2( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zhetri2_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetri2x( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, int nb ); int LAPACKE_zhetri2x_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int nb ); int LAPACKE_zhetri_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zhetrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work ); int LAPACKE_zhetrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const MKL_Complex16* a, int lda, double beta, MKL_Complex16* c ); int LAPACKE_zhfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const MKL_Complex16* a, int lda, double beta, MKL_Complex16* c ); int LAPACKE_zhgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* t, int ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zhgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* t, int ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhpcon( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zhpcon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zhpev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhpevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhpevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhpevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhpgst( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* ap, const MKL_Complex16* bp ); int LAPACKE_zhpgst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* ap, const MKL_Complex16* bp ); int LAPACKE_zhpgv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhpgvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhpgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhpgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zhprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zhpsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhpsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhpsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zhpsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zhptrd( int matrix_layout, char uplo, int n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau ); int LAPACKE_zhptrd_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau ); int LAPACKE_zhptrf( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zhptrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zhptri( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv ); int LAPACKE_zhptri_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zhptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhsein( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_zhsein_work( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr ); int LAPACKE_zhseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork ); int LAPACKE_zlacgv( int n, MKL_Complex16* x, int incx ); int LAPACKE_zlacgv_work( int n, MKL_Complex16* x, int incx ); int LAPACKE_zlacn2( int n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); int LAPACKE_zlacn2_work( int n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); int LAPACKE_zlacp2( int matrix_layout, char uplo, int m, int n, const double* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlacp2_work( int matrix_layout, char uplo, int m, int n, const double* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlacpy( int matrix_layout, char uplo, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlacpy_work( int matrix_layout, char uplo, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlag2c( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex8* sa, int ldsa ); int LAPACKE_zlag2c_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex8* sa, int ldsa ); int LAPACKE_zlagge( int matrix_layout, int m, int n, int kl, int ku, const double* d, MKL_Complex16* a, int lda, int* iseed ); int LAPACKE_zlagge_work( int matrix_layout, int m, int n, int kl, int ku, const double* d, MKL_Complex16* a, int lda, int* iseed, MKL_Complex16* work ); int LAPACKE_zlaghe( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed ); int LAPACKE_zlaghe_work( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed, MKL_Complex16* work ); int LAPACKE_zlagsy( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed ); int LAPACKE_zlagsy_work( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed, MKL_Complex16* work ); int LAPACKE_zlapmr( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlapmr_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlapmt( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlapmt_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc ); int LAPACKE_zlarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc, MKL_Complex16* work, int ldwork ); int LAPACKE_zlarfg( int n, MKL_Complex16* alpha, MKL_Complex16* x, int incx, MKL_Complex16* tau ); int LAPACKE_zlarfg_work( int n, MKL_Complex16* alpha, MKL_Complex16* x, int incx, MKL_Complex16* tau ); int LAPACKE_zlarft( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* tau, MKL_Complex16* t, int ldt ); int LAPACKE_zlarft_work( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* tau, MKL_Complex16* t, int ldt ); int LAPACKE_zlarfx( int matrix_layout, char side, int m, int n, const MKL_Complex16* v, MKL_Complex16 tau, MKL_Complex16* c, int ldc, MKL_Complex16* work ); int LAPACKE_zlarfx_work( int matrix_layout, char side, int m, int n, const MKL_Complex16* v, MKL_Complex16 tau, MKL_Complex16* c, int ldc, MKL_Complex16* work ); int LAPACKE_zlarnv( int idist, int* iseed, int n, MKL_Complex16* x ); int LAPACKE_zlarnv_work( int idist, int* iseed, int n, MKL_Complex16* x ); int LAPACKE_zlascl( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_zlascl_work( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_zlaset( int matrix_layout, char uplo, int m, int n, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16* a, int lda ); int LAPACKE_zlaset_work( int matrix_layout, char uplo, int m, int n, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16* a, int lda ); int LAPACKE_zlaswp( int matrix_layout, int n, MKL_Complex16* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_zlaswp_work( int matrix_layout, int n, MKL_Complex16* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_zlatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, MKL_Complex16* a, int lda ); int LAPACKE_zlatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, MKL_Complex16* a, int lda, MKL_Complex16* work ); int LAPACKE_zlauum( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zlauum_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpbcon( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double anorm, double* rcond ); int LAPACKE_zpbcon_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zpbequ( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_zpbequ_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_zpbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zpbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpbstf( int matrix_layout, char uplo, int n, int kb, MKL_Complex16* bb, int ldbb ); int LAPACKE_zpbstf_work( int matrix_layout, char uplo, int n, int kb, MKL_Complex16* bb, int ldbb ); int LAPACKE_zpbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zpbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpbtrf( int matrix_layout, char uplo, int n, int kd, MKL_Complex16* ab, int ldab ); int LAPACKE_zpbtrf_work( int matrix_layout, char uplo, int n, int kd, MKL_Complex16* ab, int ldab ); int LAPACKE_zpbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpftrf( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftrf_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftri( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftri_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_zpftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_zpocon( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond ); int LAPACKE_zpocon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zpoequ( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zpoequ_work( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zpoequb( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zpoequb_work( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zporfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zporfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zposv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zposv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zpotrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrf2( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrf2_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotri( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotri_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zpotrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zppcon( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double anorm, double* rcond ); int LAPACKE_zppcon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zppequ( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double* s, double* scond, double* amax ); int LAPACKE_zppequ_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double* s, double* scond, double* amax ); int LAPACKE_zpprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zpprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zppsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zppsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpptrf( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptri( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptri_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zpptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zpstrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* piv, int* rank, double tol ); int LAPACKE_zpstrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* piv, int* rank, double tol, double* work ); int LAPACKE_zptcon( int n, const double* d, const MKL_Complex16* e, double anorm, double* rcond ); int LAPACKE_zptcon_work( int n, const double* d, const MKL_Complex16* e, double anorm, double* rcond, double* work ); int LAPACKE_zpteqr( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz ); int LAPACKE_zpteqr_work( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz, double* work ); int LAPACKE_zptrfs( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zptrfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zptsv( int matrix_layout, int n, int nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zptsv_work( int matrix_layout, int n, int nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zptsvx( int matrix_layout, char fact, int n, int nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zptsvx_work( int matrix_layout, char fact, int n, int nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpttrf( int n, double* d, MKL_Complex16* e ); int LAPACKE_zpttrf_work( int n, double* d, MKL_Complex16* e ); int LAPACKE_zpttrs( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zpttrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zspcon( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zspcon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zsprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zsprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zspsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zspsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zsptrf( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zsptrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zsptri( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv ); int LAPACKE_zsptri_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zsptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zstedc( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz ); int LAPACKE_zstedc_work( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zstegr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz ); int LAPACKE_zstegr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_zstein( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, int ldz, int* ifailv ); int LAPACKE_zstein_work( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, int ldz, double* work, int* iwork, int* ifailv ); int LAPACKE_zstemr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, MKL_Complex16* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_zstemr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, MKL_Complex16* z, int ldz, int nzc, int* isuppz, int* tryrac, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_zsteqr( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz ); int LAPACKE_zsteqr_work( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz, double* work ); int LAPACKE_zsycon( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zsycon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zsyconv( int matrix_layout, char uplo, char way, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* e ); int LAPACKE_zsyconv_work( int matrix_layout, char uplo, char way, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* e ); int LAPACKE_zsyequb( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zsyequb_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax, MKL_Complex16* work ); int LAPACKE_zsyr( int matrix_layout, char uplo, int n, MKL_Complex16 alpha, const MKL_Complex16* x, int incx, MKL_Complex16* a, int lda ); int LAPACKE_zsyr_work( int matrix_layout, char uplo, int n, MKL_Complex16 alpha, const MKL_Complex16* x, int incx, MKL_Complex16* a, int lda ); int LAPACKE_zsyrfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zsyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zsyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zsyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zsysv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_rook( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsysv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zsysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zsysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zsysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zsyswapr( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zsyswapr_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zsytrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zsytrf_rook( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zsytrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytri( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zsytri2( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zsytri2_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytri2x( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, int nb ); int LAPACKE_zsytri2x_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int nb ); int LAPACKE_zsytri_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zsytrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work ); int LAPACKE_zsytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_ztbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex16* ab, int ldab, double* rcond ); int LAPACKE_ztbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex16* ab, int ldab, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_ztbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_ztbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_ztbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_ztbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_ztfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex16 alpha, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_ztfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex16 alpha, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_ztftri( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex16* a ); int LAPACKE_ztftri_work( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex16* a ); int LAPACKE_ztfttp( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* ap ); int LAPACKE_ztfttp_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* ap ); int LAPACKE_ztfttr( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* a, int lda ); int LAPACKE_ztfttr_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* a, int lda ); int LAPACKE_ztgevc( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex16* s, int lds, const MKL_Complex16* p, int ldp, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m ); int LAPACKE_ztgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex16* s, int lds, const MKL_Complex16* p, int ldp, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, MKL_Complex16* work, double* rwork ); int LAPACKE_ztgexc( int matrix_layout, int wantq, int wantz, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int ifst, int ilst ); int LAPACKE_ztgexc_work( int matrix_layout, int wantq, int wantz, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int ifst, int ilst ); int LAPACKE_ztgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int* m, double* pl, double* pr, double* dif ); int LAPACKE_ztgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, int lwork, int* iwork, int liwork ); int LAPACKE_ztgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* ncycle ); int LAPACKE_ztgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, MKL_Complex16* work, int* ncycle ); int LAPACKE_ztgsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* dif, int mm, int* m ); int LAPACKE_ztgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* dif, int mm, int* m, MKL_Complex16* work, int lwork, int* iwork ); int LAPACKE_ztgsyl( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, const MKL_Complex16* d, int ldd, const MKL_Complex16* e, int lde, MKL_Complex16* f, int ldf, double* scale, double* dif ); int LAPACKE_ztgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, const MKL_Complex16* d, int ldd, const MKL_Complex16* e, int lde, MKL_Complex16* f, int ldf, double* scale, double* dif, MKL_Complex16* work, int lwork, int* iwork ); int LAPACKE_ztpcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* ap, double* rcond ); int LAPACKE_ztpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_ztpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_ztpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work ); int LAPACKE_ztpqrt( int matrix_layout, int m, int n, int l, int nb, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt ); int LAPACKE_ztpqrt2( int matrix_layout, int m, int n, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt ); int LAPACKE_ztpqrt2_work( int matrix_layout, int m, int n, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt ); int LAPACKE_ztpqrt_work( int matrix_layout, int m, int n, int l, int nb, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt, MKL_Complex16* work ); int LAPACKE_ztprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb); int LAPACKE_ztprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work, int ldwork ); int LAPACKE_ztprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_ztprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_ztptri( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* ap ); int LAPACKE_ztptri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* ap ); int LAPACKE_ztptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_ztptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_ztpttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* arf ); int LAPACKE_ztpttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* arf ); int LAPACKE_ztpttr( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* a, int lda ); int LAPACKE_ztpttr_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* a, int lda ); int LAPACKE_ztrcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* a, int lda, double* rcond ); int LAPACKE_ztrcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* a, int lda, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_ztrevc( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m ); int LAPACKE_ztrevc_work( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, MKL_Complex16* work, double* rwork ); int LAPACKE_ztrexc( int matrix_layout, char compq, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, int ifst, int ilst ); int LAPACKE_ztrexc_work( int matrix_layout, char compq, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, int ifst, int ilst ); int LAPACKE_ztrrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_ztrrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_ztrsen( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, MKL_Complex16* w, int* m, double* s, double* sep ); int LAPACKE_ztrsen_work( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, int lwork ); int LAPACKE_ztrsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* t, int ldt, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* sep, int mm, int* m ); int LAPACKE_ztrsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* t, int ldt, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* sep, int mm, int* m, MKL_Complex16* work, int ldwork, double* rwork ); int LAPACKE_ztrsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, double* scale ); int LAPACKE_ztrsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, double* scale ); int LAPACKE_ztrtri( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* a, int lda ); int LAPACKE_ztrtri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* a, int lda ); int LAPACKE_ztrtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_ztrtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_ztrttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* arf ); int LAPACKE_ztrttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* arf ); int LAPACKE_ztrttp( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* ap ); int LAPACKE_ztrttp_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* ap ); int LAPACKE_ztzrzf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_ztzrzf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunbdb( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2 ); int LAPACKE_zunbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, int lwork ); int LAPACKE_zuncsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t ); int LAPACKE_zuncsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x21, int ldx21, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t ); int LAPACKE_zuncsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x21, int ldx21, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork ); int LAPACKE_zuncsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork ); int LAPACKE_zungbr( int matrix_layout, char vect, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungbr_work( int matrix_layout, char vect, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunghr( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zunghr_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunglq( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zunglq_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungql( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungql_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungqr( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungqr_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungrq( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungrq_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungtr( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungtr_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunmbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmql( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmql_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmrq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zupgtr( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, int ldq ); int LAPACKE_zupgtr_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, int ldq, MKL_Complex16* work ); int LAPACKE_zupmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zupmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work ); void LAPACKE_ilaver( int* vers_major, int* vers_minor, int* vers_patch ); void LAPACKE_xerbla( const char *name, int info ); int LAPACKE_chesv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chesv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf_aa( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_chetrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_dsysv_aa( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsytrf_aa( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv ); int LAPACKE_dsytrf_aa_work( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv, double* work, int lwork ); int LAPACKE_dsytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_ssysv_aa( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssytrf_aa( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv ); int LAPACKE_ssytrf_aa_work( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv, float* work, int lwork ); int LAPACKE_ssytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_zhesv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhesv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf_aa( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zhetrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_cgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc ); int LAPACKE_cgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqr( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize ); int LAPACKE_cgeqr_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize, MKL_Complex8* work, int lwork ); int LAPACKE_dgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc ); int LAPACKE_dgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc, double* work, int lwork ); int LAPACKE_dgeqr( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize ); int LAPACKE_dgeqr_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize, double* work, int lwork ); int LAPACKE_sgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc ); int LAPACKE_sgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc, float* work, int lwork ); int LAPACKE_sgeqr( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize ); int LAPACKE_sgeqr_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize, float* work, int lwork ); int LAPACKE_zgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc ); int LAPACKE_zgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqr( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize ); int LAPACKE_zgeqr_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize, MKL_Complex16* work, int lwork ); int LAPACKE_cgelq( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize ); int LAPACKE_cgelq_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize, MKL_Complex8* work, int lwork ); int LAPACKE_cgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc ); int LAPACKE_cgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_dgelq( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize ); int LAPACKE_dgelq_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize, double* work, int lwork ); int LAPACKE_dgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc ); int LAPACKE_dgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc, double* work, int lwork ); int LAPACKE_sgelq( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize ); int LAPACKE_sgelq_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize, float* work, int lwork ); int LAPACKE_sgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc ); int LAPACKE_sgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc, float* work, int lwork ); int LAPACKE_zgelq( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize ); int LAPACKE_zgelq_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize, MKL_Complex16* work, int lwork ); int LAPACKE_zgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc ); int LAPACKE_zgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_cgetsls( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_dgetsls( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* work, int lwork ); int LAPACKE_sgetsls( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* work, int lwork ); int LAPACKE_zgetsls( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_checon_3( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond ); int LAPACKE_checon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_chesv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chesv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf_rk( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv ); int LAPACKE_chetrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetri_3( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv ); int LAPACKE_chetri_3_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csycon_3( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond ); int LAPACKE_csycon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_csysv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csysv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csytrf_aa( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_csytrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytrf_rk( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv ); int LAPACKE_csytrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytri_3( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv ); int LAPACKE_csytri_3_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_dsycon_3( int matrix_layout, char uplo, int n, const double* a, int lda, const double* e, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dsycon_3_work( int matrix_layout, char uplo, int n, const double* a, int lda, const double* e, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dsysv_rk( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* e, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* e, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsytrf_rk( int matrix_layout, char uplo, int n, double* a, int lda, double* e, int* ipiv ); int LAPACKE_dsytrf_rk_work( int matrix_layout, char uplo, int n, double* a, int lda, double* e, int* ipiv, double* work, int lwork ); int LAPACKE_dsytri_3( int matrix_layout, char uplo, int n, double* a, int lda, const double* e, const int* ipiv ); int LAPACKE_dsytri_3_work( int matrix_layout, char uplo, int n, double* a, int lda, const double* e, const int* ipiv, double* work, int lwork ); int LAPACKE_dsytrs_3( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* e, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* e, const int* ipiv, double* b, int ldb ); int LAPACKE_ssycon_3( int matrix_layout, char uplo, int n, const float* a, int lda, const float* e, const int* ipiv, float anorm, float* rcond ); int LAPACKE_ssycon_3_work( int matrix_layout, char uplo, int n, const float* a, int lda, const float* e, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_ssysv_rk( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* e, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* e, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssytrf_rk( int matrix_layout, char uplo, int n, float* a, int lda, float* e, int* ipiv ); int LAPACKE_ssytrf_rk_work( int matrix_layout, char uplo, int n, float* a, int lda, float* e, int* ipiv, float* work, int lwork ); int LAPACKE_ssytri_3( int matrix_layout, char uplo, int n, float* a, int lda, const float* e, const int* ipiv ); int LAPACKE_ssytri_3_work( int matrix_layout, char uplo, int n, float* a, int lda, const float* e, const int* ipiv, float* work, int lwork ); int LAPACKE_ssytrs_3( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* e, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* e, const int* ipiv, float* b, int ldb ); int LAPACKE_zhecon_3( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zhecon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zhesv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhesv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf_rk( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv ); int LAPACKE_zhetrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetri_3( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv ); int LAPACKE_zhetri_3_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsycon_3( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zsycon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zsysv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsysv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrf_aa( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zsytrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrf_rk( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv ); int LAPACKE_zsytrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytri_3( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv ); int LAPACKE_zsytri_3_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_chbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_cheev_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheev_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cheevd_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz ); int LAPACKE_cheevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_cheevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_chegv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w ); int LAPACKE_chegv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_dsbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work, int lwork ); int LAPACKE_dsbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsyev_2stage( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyev_2stage_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork ); int LAPACKE_dsyevd_2stage( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dsyevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsyevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsygv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w ); int LAPACKE_dsygv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w, double* work, int lwork ); int LAPACKE_ssbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work, int lwork ); int LAPACKE_ssbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssyev_2stage( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyev_2stage_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork ); int LAPACKE_ssyevd_2stage( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_ssyevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssyevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssygv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w ); int LAPACKE_ssygv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w, float* work, int lwork ); int LAPACKE_zhbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zheev_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheev_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zheevd_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz ); int LAPACKE_zheevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zheevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhegv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w ); int LAPACKE_zhegv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_mkl_cgetrfnp( int matrix_layout, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_mkl_cgetrfnp_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_mkl_dgetrfnp( int matrix_layout, int m, int n, double* a, int lda ); int LAPACKE_mkl_dgetrfnp_work( int matrix_layout, int m, int n, double* a, int lda ); int LAPACKE_mkl_sgetrfnp( int matrix_layout, int m, int n, float* a, int lda ); int LAPACKE_mkl_sgetrfnp_work( int matrix_layout, int m, int n, float* a, int lda ); int LAPACKE_mkl_zgetrfnp( int matrix_layout, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_mkl_zgetrfnp_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_mkl_cgetrinp( int matrix_layout, int n, MKL_Complex8* a, int lda ); int LAPACKE_mkl_cgetrinp_work( int matrix_layout, int n, MKL_Complex8* a, int lda, MKL_Complex8* work, int lwork ); int LAPACKE_mkl_dgetrinp( int matrix_layout, int n, double* a, int lda ); int LAPACKE_mkl_dgetrinp_work( int matrix_layout, int n, double* a, int lda, double* work, int lwork ); int LAPACKE_mkl_sgetrinp( int matrix_layout, int n, float* a, int lda ); int LAPACKE_mkl_sgetrinp_work( int matrix_layout, int n, float* a, int lda, float* work, int lwork ); int LAPACKE_mkl_zgetrinp( int matrix_layout, int n, MKL_Complex16* a, int lda ); int LAPACKE_mkl_zgetrinp_work( int matrix_layout, int n, MKL_Complex16* a, int lda, MKL_Complex16* work, int lwork ); void LAPACKE_set_nancheck( int flag ); int LAPACKE_get_nancheck( ); #line 45 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_pardiso.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" typedef void * _MKL_DSS_HANDLE_t; typedef char _CHARACTER_t; typedef char _CHARACTER_STR_t; typedef long long _LONG_t; typedef float _REAL_t; typedef double _DOUBLE_PRECISION_t; typedef struct { double r, i; } _DOUBLE_COMPLEX_t; #line 123 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 134 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 145 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 156 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 197 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" extern int __cdecl dss_create_ (_MKL_DSS_HANDLE_t *, int const *); extern int __cdecl dss_define_structure_ (_MKL_DSS_HANDLE_t *, int const *, int const *, int const *, int const *, int const *, int const *); extern int __cdecl dss_reorder_ (_MKL_DSS_HANDLE_t *, int const *, int const *); extern int __cdecl dss_factor_real_ (_MKL_DSS_HANDLE_t *, int const *, void const *); extern int __cdecl dss_factor_complex_ (_MKL_DSS_HANDLE_t *, int const *, void const *); extern int __cdecl dss_solve_real_ (_MKL_DSS_HANDLE_t *, int const *, void const *, int const *, void *); extern int __cdecl dss_solve_complex_ (_MKL_DSS_HANDLE_t *, int const *, void const *, int const *, void *); extern int __cdecl dss_statistics_ ( _MKL_DSS_HANDLE_t *, int const *, _CHARACTER_STR_t const *, _DOUBLE_PRECISION_t *); extern int __cdecl dss_delete_ (_MKL_DSS_HANDLE_t const *, int const *); #line 250 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 271 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 27 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_pardiso.h" #line 44 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_pardiso.h" extern void __cdecl pardiso ( _MKL_DSS_HANDLE_t, const int *, const int *, const int *, const int *, const int *, const void *, const int *, const int *, int *, const int *, int *, const int *, void *, void *, int *); extern void __cdecl PARDISO ( _MKL_DSS_HANDLE_t, const int *, const int *, const int *, const int *, const int *, const void *, const int *, const int *, int *, const int *, int *, const int *, void *, void *, int *); extern void __cdecl pardisoinit ( _MKL_DSS_HANDLE_t, const int *, int *); extern void __cdecl PARDISOINIT ( _MKL_DSS_HANDLE_t, const int *, int *); extern void __cdecl pardiso_64 ( _MKL_DSS_HANDLE_t, const long long int *, const long long int *, const long long int *, const long long int *, const long long int *, const void *, const long long int *, const long long int *, long long int *, const long long int *, long long int *, const long long int *, void *, void *, long long int *); extern void __cdecl PARDISO_64 ( _MKL_DSS_HANDLE_t, const long long int *, const long long int *, const long long int *, const long long int *, const long long int *, const void *, const long long int *, const long long int *, long long int *, const long long int *, long long int *, const long long int *, void *, void *, long long int *); extern void __cdecl pardiso_handle_store_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_STORE_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_restore_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_RESTORE_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_delete_64 ( const char*, int *);; extern void __cdecl PARDISO_HANDLE_DELETE_64 ( const char*, int *);; enum PARDISO_ENV_PARAM { PARDISO_OOC_FILE_NAME = 1 }; extern int __cdecl pardiso_getenv (const _MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, char*); extern int __cdecl PARDISO_GETENV (const _MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, char*); extern int __cdecl pardiso_setenv (_MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, const char*); extern int __cdecl PARDISO_SETENV (_MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, const char*); extern void __cdecl pardiso_handle_store ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_STORE ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_restore ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_RESTORE ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_delete ( const char*, int *);; extern void __cdecl PARDISO_HANDLE_DELETE ( const char*, int *);; extern int __cdecl MKL_PARDISO_PIVOT ( const double* aii, double* bii, const double* eps ); extern int __cdecl MKL_PARDISO_PIVOT_ ( const double* aii, double* bii, const double* eps ); extern int __cdecl mkl_pardiso_pivot ( const double* aii, double* bii, const double* eps ); extern int __cdecl mkl_pardiso_pivot_ ( const double* aii, double* bii, const double* eps ); extern void __cdecl pardiso_getdiag ( const _MKL_DSS_HANDLE_t, void *, void *, const int *, int * ); extern void __cdecl pardiso_export ( void *, void *, int *, int *, const int *, const int *, int * ); #line 46 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_sparse_handle.h" #line 42 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_sparse_handle.h" typedef enum { MKL_ZERO_BASED, MKL_ONE_BASED } sparse_matrix_indexing; typedef enum { MKL_C_STYLE, MKL_FORTRAN_STYLE } sparse_matrix_print_styles; typedef enum { MKL_CSR } sparse_matrix_formats; typedef enum { MKL_GENERAL_STRUCTURE, MKL_UPPER_TRIANGULAR, MKL_LOWER_TRIANGULAR, MKL_STRUCTURAL_SYMMETRIC } sparse_matrix_structures; typedef enum { MKL_NO_PRINT, MKL_PRINT } sparse_matrix_message_levels; typedef enum { MKL_SPARSE_CHECKER_SUCCESS = 0, MKL_SPARSE_CHECKER_NON_MONOTONIC = 21, MKL_SPARSE_CHECKER_OUT_OF_RANGE = 22, MKL_SPARSE_CHECKER_NONTRIANGULAR = 23, MKL_SPARSE_CHECKER_NONORDERED = 24} sparse_checker_error_values; typedef struct _sparse_struct { int n, *csr_ia, *csr_ja, check_result[3]; sparse_matrix_indexing indexing; sparse_matrix_structures matrix_structure; sparse_matrix_formats matrix_format; sparse_matrix_message_levels message_level; sparse_matrix_print_styles print_style; } sparse_struct; extern void __cdecl sparse_matrix_checker_init (sparse_struct*); extern sparse_checker_error_values __cdecl sparse_matrix_checker (sparse_struct*); #line 47 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_rci.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" #pragma once __pragma(pack(push, 8)) #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __declspec(allocator) __declspec(restrict) void* __cdecl _calloc_base( size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl calloc( size_t _Count, size_t _Size ); int __cdecl _callnewh( size_t _Size ); __declspec(allocator) void* __cdecl _expand( void* _Block, size_t _Size ); void __cdecl _free_base( void* _Block ); void __cdecl free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _malloc_base( size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl malloc( size_t _Size ); size_t __cdecl _msize_base( void* _Block ); size_t __cdecl _msize( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _realloc_base( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl realloc( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc_base( void* _Block, size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc( void* _Block, size_t _Count, size_t _Size ); void __cdecl _aligned_free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_malloc( size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_malloc( size_t _Size, size_t _Alignment, size_t _Offset ); size_t __cdecl _aligned_msize( void* _Block, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_realloc( void* _Block, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_realloc( void* _Block, size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment ); #line 225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" #pragma once __pragma(pack(push, 8)) typedef int (__cdecl* _CoreCrtSecureSearchSortCompareFunction)(void*, void const*, void const*); typedef int (__cdecl* _CoreCrtNonSecureSearchSortCompareFunction)(void const*, void const*); void* __cdecl bsearch_s( void const* _Key, void const* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void __cdecl qsort_s( void* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl bsearch( void const* _Key, void const* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void __cdecl qsort( void* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lfind_s( void const* _Key, void const* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lsearch_s( void const* _Key, void* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); #line 185 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lfind" ". See online help for details.")) void* __cdecl lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lsearch" ". See online help for details.")) void* __cdecl lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma once __pragma(pack(push, 8)) errno_t __cdecl _itow_s( int _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _itow(int _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ltow_s( long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ltow(long _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ultow_s( unsigned long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ultow(unsigned long _Value, wchar_t *_Buffer, int _Radix); double __cdecl wcstod( wchar_t const* _String, wchar_t** _EndPtr ); double __cdecl _wcstod_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); long __cdecl wcstol( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long __cdecl _wcstol_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl wcstoll( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long long __cdecl _wcstoll_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl wcstoul( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long __cdecl _wcstoul_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl wcstoull( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long long __cdecl _wcstoull_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long double __cdecl wcstold( wchar_t const* _String, wchar_t** _EndPtr ); long double __cdecl _wcstold_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); float __cdecl wcstof( wchar_t const* _String, wchar_t** _EndPtr ); float __cdecl _wcstof_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); double __cdecl _wtof( wchar_t const* _String ); double __cdecl _wtof_l( wchar_t const* _String, _locale_t _Locale ); int __cdecl _wtoi( wchar_t const* _String ); int __cdecl _wtoi_l( wchar_t const* _String, _locale_t _Locale ); long __cdecl _wtol( wchar_t const* _String ); long __cdecl _wtol_l( wchar_t const* _String, _locale_t _Locale ); long long __cdecl _wtoll( wchar_t const* _String ); long long __cdecl _wtoll_l( wchar_t const* _String, _locale_t _Locale ); errno_t __cdecl _i64tow_s( __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _i64tow( __int64 _Value, wchar_t* _Buffer, int _Radix ); errno_t __cdecl _ui64tow_s( unsigned __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ui64tow( unsigned __int64 _Value, wchar_t* _Buffer, int _Radix ); __int64 __cdecl _wtoi64( wchar_t const* _String ); __int64 __cdecl _wtoi64_l( wchar_t const* _String, _locale_t _Locale ); __int64 __cdecl _wcstoi64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); __int64 __cdecl _wcstoi64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _wcstoui64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned __int64 __cdecl _wcstoui64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); __declspec(allocator) wchar_t* __cdecl _wfullpath( wchar_t* _Buffer, wchar_t const* _Path, size_t _BufferCount ); errno_t __cdecl _wmakepath_s( wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext ); #line 361 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wmakepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wmakepath( wchar_t *_Buffer, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext); #pragma warning(pop) void __cdecl _wperror( wchar_t const* _ErrorMessage ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsplitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsplitpath( wchar_t const* _FullPath, wchar_t* _Drive, wchar_t* _Dir, wchar_t* _Filename, wchar_t* _Ext ); errno_t __cdecl _wsplitpath_s( wchar_t const* _FullPath, wchar_t* _Drive, size_t _DriveCount, wchar_t* _Dir, size_t _DirCount, wchar_t* _Filename, size_t _FilenameCount, wchar_t* _Ext, size_t _ExtCount ); errno_t __cdecl _wdupenv_s( wchar_t** _Buffer, size_t* _BufferCount, wchar_t const* _VarName ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wdupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wgetenv( wchar_t const* _VarName ); errno_t __cdecl _wgetenv_s( size_t* _RequiredCount, wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _VarName ); #line 438 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" int __cdecl _wputenv( wchar_t const* _EnvString ); errno_t __cdecl _wputenv_s( wchar_t const* _Name, wchar_t const* _Value ); errno_t __cdecl _wsearchenv_s( wchar_t const* _Filename, wchar_t const* _VarName, wchar_t* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsearchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsearchenv(wchar_t const* _Filename, wchar_t const* _VarName, wchar_t *_ResultPath); int __cdecl _wsystem( wchar_t const* _Command ); __pragma(pack(pop)) #line 16 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #pragma once __pragma(pack(push, 8)) #line 29 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 43 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 71 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 79 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" __pragma(pack(pop)) #line 17 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __pragma(pack(push, 8)) void __cdecl _swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(noreturn) void __cdecl exit( int _Code); __declspec(noreturn) void __cdecl _exit( int _Code); __declspec(noreturn) void __cdecl _Exit( int _Code); __declspec(noreturn) void __cdecl quick_exit( int _Code); __declspec(noreturn) void __cdecl abort(void); unsigned int __cdecl _set_abort_behavior( unsigned int _Flags, unsigned int _Mask ); typedef int (__cdecl* _onexit_t)(void); #line 117 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 140 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl atexit(void (__cdecl*)(void)); _onexit_t __cdecl _onexit( _onexit_t _Func); int __cdecl at_quick_exit(void (__cdecl*)(void)); typedef void (__cdecl* _purecall_handler)(void); typedef void (__cdecl* _invalid_parameter_handler)( wchar_t const*, wchar_t const*, wchar_t const*, unsigned int, uintptr_t ); _purecall_handler __cdecl _set_purecall_handler( _purecall_handler _Handler ); _purecall_handler __cdecl _get_purecall_handler(void); _invalid_parameter_handler __cdecl _set_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_invalid_parameter_handler(void); _invalid_parameter_handler __cdecl _set_thread_local_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_thread_local_invalid_parameter_handler(void); #line 199 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl _set_error_mode( int _Mode); int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); unsigned long* __cdecl __doserrno(void); errno_t __cdecl _set_doserrno( unsigned long _Value); errno_t __cdecl _get_doserrno( unsigned long * _Value); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __sys_errlist(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int * __cdecl __sys_nerr(void); void __cdecl perror( char const* _ErrMsg); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_pgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __p__pgmptr (void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_wpgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t** __cdecl __p__wpgmptr(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_fmode" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int* __cdecl __p__fmode (void); #line 253 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" errno_t __cdecl _get_pgmptr ( char** _Value); errno_t __cdecl _get_wpgmptr( wchar_t** _Value); errno_t __cdecl _set_fmode ( int _Mode ); errno_t __cdecl _get_fmode ( int* _PMode); typedef struct _div_t { int quot; int rem; } div_t; typedef struct _ldiv_t { long quot; long rem; } ldiv_t; typedef struct _lldiv_t { long long quot; long long rem; } lldiv_t; int __cdecl abs ( int _Number); long __cdecl labs ( long _Number); long long __cdecl llabs ( long long _Number); __int64 __cdecl _abs64( __int64 _Number); unsigned short __cdecl _byteswap_ushort( unsigned short _Number); unsigned long __cdecl _byteswap_ulong ( unsigned long _Number); unsigned __int64 __cdecl _byteswap_uint64( unsigned __int64 _Number); div_t __cdecl div ( int _Numerator, int _Denominator); ldiv_t __cdecl ldiv ( long _Numerator, long _Denominator); lldiv_t __cdecl lldiv( long long _Numerator, long long _Denominator); #pragma warning (push) #pragma warning (disable:6540) unsigned int __cdecl _rotl( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotl( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotl64( unsigned __int64 _Value, int _Shift ); unsigned int __cdecl _rotr( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotr( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotr64( unsigned __int64 _Value, int _Shift ); #pragma warning (pop) void __cdecl srand( unsigned int _Seed); int __cdecl rand(void); #line 380 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma pack(push, 4) typedef struct { unsigned char ld[10]; } _LDOUBLE; #pragma pack(pop) #line 410 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" typedef struct { double x; } _CRT_DOUBLE; typedef struct { float f; } _CRT_FLOAT; typedef struct { long double x; } _LONGDOUBLE; #pragma pack(push, 4) typedef struct { unsigned char ld12[12]; } _LDBL12; #pragma pack(pop) double __cdecl atof ( char const* _String); int __cdecl atoi ( char const* _String); long __cdecl atol ( char const* _String); long long __cdecl atoll ( char const* _String); __int64 __cdecl _atoi64( char const* _String); double __cdecl _atof_l ( char const* _String, _locale_t _Locale); int __cdecl _atoi_l ( char const* _String, _locale_t _Locale); long __cdecl _atol_l ( char const* _String, _locale_t _Locale); long long __cdecl _atoll_l ( char const* _String, _locale_t _Locale); __int64 __cdecl _atoi64_l( char const* _String, _locale_t _Locale); int __cdecl _atoflt ( _CRT_FLOAT* _Result, char const* _String); int __cdecl _atodbl ( _CRT_DOUBLE* _Result, char* _String); int __cdecl _atoldbl( _LDOUBLE* _Result, char* _String); int __cdecl _atoflt_l( _CRT_FLOAT* _Result, char const* _String, _locale_t _Locale ); int __cdecl _atodbl_l( _CRT_DOUBLE* _Result, char* _String, _locale_t _Locale ); int __cdecl _atoldbl_l( _LDOUBLE* _Result, char* _String, _locale_t _Locale ); float __cdecl strtof( char const* _String, char** _EndPtr ); float __cdecl _strtof_l( char const* _String, char** _EndPtr, _locale_t _Locale ); double __cdecl strtod( char const* _String, char** _EndPtr ); double __cdecl _strtod_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long double __cdecl strtold( char const* _String, char** _EndPtr ); long double __cdecl _strtold_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long __cdecl strtol( char const* _String, char** _EndPtr, int _Radix ); long __cdecl _strtol_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl strtoll( char const* _String, char** _EndPtr, int _Radix ); long long __cdecl _strtoll_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl strtoul( char const* _String, char** _EndPtr, int _Radix ); unsigned long __cdecl _strtoul_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl strtoull( char const* _String, char** _EndPtr, int _Radix ); unsigned long long __cdecl _strtoull_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); __int64 __cdecl _strtoi64( char const* _String, char** _EndPtr, int _Radix ); __int64 __cdecl _strtoi64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _strtoui64( char const* _String, char** _EndPtr, int _Radix ); unsigned __int64 __cdecl _strtoui64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); errno_t __cdecl _itoa_s( int _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _itoa(int _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _ltoa_s( long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ltoa(long _Value, char *_Buffer, int _Radix); errno_t __cdecl _ultoa_s( unsigned long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ultoa(unsigned long _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _i64toa_s( __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _i64toa( __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ui64toa_s( unsigned __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ui64toa( unsigned __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ecvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _fcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _gcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _gcvt( double _Value, int _DigitCount, char* _Buffer ); #line 838 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl ___mb_cur_max_func(void); int __cdecl ___mb_cur_max_l_func(_locale_t _Locale); int __cdecl mblen( char const* _Ch, size_t _MaxCount ); int __cdecl _mblen_l( char const* _Ch, size_t _MaxCount, _locale_t _Locale ); size_t __cdecl _mbstrlen( char const* _String ); size_t __cdecl _mbstrlen_l( char const* _String, _locale_t _Locale ); size_t __cdecl _mbstrnlen( char const* _String, size_t _MaxCount ); size_t __cdecl _mbstrnlen_l( char const* _String, size_t _MaxCount, _locale_t _Locale ); int __cdecl mbtowc( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes ); int __cdecl _mbtowc_l( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes, _locale_t _Locale ); errno_t __cdecl mbstowcs_s( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "mbstowcs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl mbstowcs( wchar_t *_Dest, char const* _Source, size_t _MaxCount); errno_t __cdecl _mbstowcs_s_l( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_mbstowcs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _mbstowcs_l( wchar_t *_Dest, char const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wctomb_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl wctomb( char* _MbCh, wchar_t _WCh ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctomb_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _wctomb_l( char* _MbCh, wchar_t _WCh, _locale_t _Locale ); errno_t __cdecl wctomb_s( int* _SizeConverted, char* _MbCh, rsize_t _SizeInBytes, wchar_t _WCh ); errno_t __cdecl _wctomb_s_l( int* _SizeConverted, char* _MbCh, size_t _SizeInBytes, wchar_t _WCh, _locale_t _Locale); errno_t __cdecl wcstombs_s( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstombs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl wcstombs( char *_Dest, wchar_t const* _Source, size_t _MaxCount); errno_t __cdecl _wcstombs_s_l( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcstombs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _wcstombs_l( char *_Dest, wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(allocator) char* __cdecl _fullpath( char* _Buffer, char const* _Path, size_t _BufferCount ); errno_t __cdecl _makepath_s( char* _Buffer, size_t _BufferCount, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_makepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _makepath( char *_Buffer, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext); #pragma warning(pop) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_splitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _splitpath( char const* _FullPath, char* _Drive, char* _Dir, char* _Filename, char* _Ext ); errno_t __cdecl _splitpath_s( char const* _FullPath, char* _Drive, size_t _DriveCount, char* _Dir, size_t _DirCount, char* _Filename, size_t _FilenameCount, char* _Ext, size_t _ExtCount ); errno_t __cdecl getenv_s( size_t* _RequiredCount, char* _Buffer, rsize_t _BufferCount, char const* _VarName ); int* __cdecl __p___argc (void); char*** __cdecl __p___argv (void); wchar_t*** __cdecl __p___wargv(void); #line 1164 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" char*** __cdecl __p__environ (void); wchar_t*** __cdecl __p__wenviron(void); #line 1181 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "_dupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl getenv( char const* _VarName ); errno_t __cdecl _dupenv_s( char** _Buffer, size_t* _BufferCount, char const* _VarName ); int __cdecl system( char const* _Command ); #pragma warning (push) #pragma warning (disable:6540) int __cdecl _putenv( char const* _EnvString ); errno_t __cdecl _putenv_s( char const* _Name, char const* _Value ); #pragma warning (pop) errno_t __cdecl _searchenv_s( char const* _Filename, char const* _VarName, char* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_searchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _searchenv(char const* _Filename, char const* _VarName, char *_Buffer); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "SetErrorMode" " " "instead. See online help for details.")) void __cdecl _seterrormode( int _Mode ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Beep" " " "instead. See online help for details.")) void __cdecl _beep( unsigned _Frequency, unsigned _Duration ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Sleep" " " "instead. See online help for details.")) void __cdecl _sleep( unsigned long _Duration ); #pragma warning(push) #pragma warning(disable: 4141) __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ecvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_fcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_gcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl gcvt( double _Value, int _DigitCount, char* _DstBuf ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_itoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl itoa( int _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ltoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ltoa( long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_swab" ". See online help for details.")) void __cdecl swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ultoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ultoa( unsigned long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_putenv" ". See online help for details.")) int __cdecl putenv( char const* _EnvString ); #pragma warning(pop) _onexit_t __cdecl onexit( _onexit_t _Func); __pragma(pack(pop)) #line 24 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" extern void __cdecl MKL_Get_Version (MKLVersion *ver); extern void __cdecl MKL_Get_Version_String (char * buffer, int len); extern void __cdecl MKL_Free_Buffers (void); extern void __cdecl MKL_Thread_Free_Buffers (void); extern long long int __cdecl MKL_Mem_Stat (int* nbuffers); extern long long int __cdecl MKL_Peak_Mem_Usage (int reset); extern void* __cdecl MKL_malloc (size_t size, int align); extern void* __cdecl MKL_calloc (size_t num, size_t size, int align); extern void* __cdecl MKL_realloc (void *ptr, size_t size); extern void __cdecl MKL_free (void *ptr); extern int __cdecl MKL_Disable_Fast_MM (void); extern void __cdecl MKL_Get_Cpu_Clocks (unsigned long long int *); extern double __cdecl MKL_Get_Cpu_Frequency (void); extern double __cdecl MKL_Get_Max_Cpu_Frequency (void); extern double __cdecl MKL_Get_Clocks_Frequency (void); extern int __cdecl MKL_Set_Num_Threads_Local (int nth); extern void __cdecl MKL_Set_Num_Threads (int nth); extern int __cdecl MKL_Get_Max_Threads (void); extern void __cdecl MKL_Set_Num_Stripes (int nstripes); extern int __cdecl MKL_Get_Num_Stripes (void); extern int __cdecl MKL_Domain_Set_Num_Threads (int nth, int MKL_DOMAIN); extern int __cdecl MKL_Domain_Get_Max_Threads (int MKL_DOMAIN); extern void __cdecl MKL_Set_Dynamic (int bool_MKL_DYNAMIC); extern int __cdecl MKL_Get_Dynamic (void); #line 124 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" extern int __cdecl MKL_Enable_Instructions (int); #line 135 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" extern int __cdecl MKL_Set_Interface_Layer (int code); extern int __cdecl MKL_Set_Threading_Layer (int code); typedef void (* XerblaEntry) (const char * Name, const int * Num, const int Len); extern XerblaEntry __cdecl mkl_set_xerbla (XerblaEntry xerbla); typedef int (* ProgressEntry) (int* thread, int* step, char* stage, int stage_len); extern ProgressEntry __cdecl mkl_set_progress (ProgressEntry progress); extern int __cdecl MKL_CBWR_Get (int); extern int __cdecl MKL_CBWR_Set (int); extern int __cdecl MKL_CBWR_Get_Auto_Branch (void); extern int __cdecl MKL_Set_Env_Mode (int); extern int __cdecl MKL_Verbose (int); extern int __cdecl MKL_Verbose_Output_File (char *); typedef void (* MKLExitHandler)(int why); extern void __cdecl MKL_Set_Exit_Handler (MKLExitHandler h);; extern int __cdecl MKL_Set_Memory_Limit (int mem_type,size_t limit);; enum { MKL_BLACS_CUSTOM = 0, MKL_BLACS_MSMPI = 1, MKL_BLACS_INTELMPI = 2, MKL_BLACS_MPICH2 = 3, MKL_BLACS_LASTMPI = 4 }; int MKL_Set_mpi(int vendor, const char *custom_library_name); extern void __cdecl MKL_Finalize (void);; #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_rci.h" #line 38 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_rci.h" extern void __cdecl dcsrilu0 (const int *n, const double *a, const int *ia, const int *ja, double *alu, const int *ipar, const double *dpar,int *ierr); extern void __cdecl dcsrilut (const int *n, const double *a, const int *ia, const int *ja, double *alut,int *ialut, int *jalut, const double * tol, const int *maxfil, const int *ipar, const double *dpar,int *ierr); extern void __cdecl DCSRILU0 (const int *n, const double *a, const int *ia, const int *ja, double *alu, const int *ipar, const double *dpar,int *ierr); extern void __cdecl DCSRILUT (const int *n, const double *a, const int *ia, const int *ja, double *alut,int *ialut, int *jalut, const double * tol, const int *maxfil, const int *ipar, const double *dpar,int *ierr); extern void __cdecl dcg_init (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcg_check (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcg (const int *n, double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcg_get (const int *n, const double *x, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl dcgmrhs_init (const int *n, const double *x, const int* nRhs, const double *b, const int *method, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcgmrhs_check (const int *n, const double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcgmrhs (const int *n, double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcgmrhs_get (const int *n, const double *x, const int* nRhs, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl dfgmres_init (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dfgmres_check (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dfgmres (const int *n, double *x, double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dfgmres_get (const int *n, double *x, double *b, int *RCI_request, const int *ipar, const double *dpar, double *tmp, int *itercount); extern void __cdecl DCG_INIT (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCG_CHECK (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCG (const int *n, double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCG_GET (const int *n, const double *x, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl DCGMRHS_INIT (const int *n, const double *x, const int* nRhs, const double *b, const int *method, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCGMRHS_CHECK (const int *n, const double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCGMRHS (const int *n, double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCGMRHS_GET (const int *n, const double *x, const int* nRhs, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl DFGMRES_INIT (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DFGMRES_CHECK (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DFGMRES (const int *n, double *x, double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DFGMRES_GET (const int *n, double *x, double *b, int *RCI_request, const int *ipar, const double *dpar, double *tmp, int *itercount); typedef void* _TRNSP_HANDLE_t; typedef void* _TRNSPBC_HANDLE_t; typedef void* _JACOBIMATRIX_HANDLE_t; typedef void(*USRFCND) (int*,int*,double*,double*); typedef void(*USRFCNXD) (int*,int*,double*,double*,void*); typedef void(*USRFCNS) (int*,int*,float*,float*); typedef void(*USRFCNXS) (int*,int*,float*,float*,void*); extern int __cdecl dtrnlsp_init (_TRNSP_HANDLE_t*, const int*, const int*, const double*, const double*, const int*, const int*, const double*); extern int __cdecl dtrnlsp_check (_TRNSP_HANDLE_t*, const int*, const int*, const double*, const double*, const double*, int*); extern int __cdecl dtrnlsp_solve (_TRNSP_HANDLE_t*, double*, double*, int*); extern int __cdecl dtrnlsp_get (_TRNSP_HANDLE_t*, int*, int*, double*, double*); extern int __cdecl dtrnlsp_delete (_TRNSP_HANDLE_t*); extern int __cdecl dtrnlspbc_init (_TRNSPBC_HANDLE_t*, const int*, const int*, const double*, const double*, const double*, const double*, const int*, const int*, const double*); extern int __cdecl dtrnlspbc_check (_TRNSPBC_HANDLE_t*, const int*, const int*, const double*, const double*, const double*, const double*, const double*, int*); extern int __cdecl dtrnlspbc_solve (_TRNSPBC_HANDLE_t*, double*, double*, int*); extern int __cdecl dtrnlspbc_get (_TRNSPBC_HANDLE_t*, int*, int*, double*, double*); extern int __cdecl dtrnlspbc_delete (_TRNSPBC_HANDLE_t*); extern int __cdecl djacobi_init (_JACOBIMATRIX_HANDLE_t*, const int*, const int*, const double*, const double*, const double*); extern int __cdecl djacobi_solve (_JACOBIMATRIX_HANDLE_t*, double*, double*, int*); extern int __cdecl djacobi_delete (_JACOBIMATRIX_HANDLE_t*); extern int __cdecl djacobi (USRFCND fcn, const int*, const int*, double*, double*, double*); extern int __cdecl djacobix (USRFCNXD fcn, const int*, const int*, double*, double*, double*,void*); extern int __cdecl strnlsp_init (_TRNSP_HANDLE_t*, const int*, const int*, const float*, const float*, const int*, const int*, const float*); extern int __cdecl strnlsp_check (_TRNSP_HANDLE_t*, const int*, const int*, const float*, const float*, const float*, int*); extern int __cdecl strnlsp_solve (_TRNSP_HANDLE_t*, float*, float*, int*); extern int __cdecl strnlsp_get (_TRNSP_HANDLE_t*, int*, int*, float*, float*); extern int __cdecl strnlsp_delete (_TRNSP_HANDLE_t*); extern int __cdecl strnlspbc_init (_TRNSPBC_HANDLE_t*, const int*, const int*, const float*, const float*, const float*, const float*, const int*, const int*, const float*); extern int __cdecl strnlspbc_check (_TRNSPBC_HANDLE_t*, const int*, const int*, const float*, const float*, const float*, const float*, const float*, int*); extern int __cdecl strnlspbc_solve (_TRNSPBC_HANDLE_t*, float*, float*, int*); extern int __cdecl strnlspbc_get (_TRNSPBC_HANDLE_t*, int*, int*, float*, float*); extern int __cdecl strnlspbc_delete (_TRNSPBC_HANDLE_t*); extern int __cdecl sjacobi_init (_JACOBIMATRIX_HANDLE_t*, const int*, const int*, const float*, const float*, const float*); extern int __cdecl sjacobi_solve (_JACOBIMATRIX_HANDLE_t*, float*, float*, int*); extern int __cdecl sjacobi_delete (_JACOBIMATRIX_HANDLE_t*); extern int __cdecl sjacobi (USRFCNS fcn, const int*, const int*, float*, float*, float*); extern int __cdecl sjacobix (USRFCNXS fcn, const int*, const int*, float*, float*, float*,void*); #line 49 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 108 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 168 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 189 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_types.h" typedef struct _DefVmlErrorContext { int iCode; int iIndex; double dbA1; double dbA2; double dbR1; double dbR2; char cFuncName[64]; int iFuncNameLen; double dbA1Im; double dbA2Im; double dbR1Im; double dbR2Im; } DefVmlErrorContext; typedef int (*VMLErrorCallBack) (DefVmlErrorContext* pdefVmlErrorContext); #line 32 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_functions.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_functions.h" extern void __cdecl VSABS (const int *n, const float a[], float r[]); extern void __cdecl VDABS (const int *n, const double a[], double r[]); extern void __cdecl vsabs (const int *n, const float a[], float r[]); extern void __cdecl vdabs (const int *n, const double a[], double r[]); extern void __cdecl vsAbs (const int n, const float a[], float r[]); extern void __cdecl vdAbs (const int n, const double a[], double r[]); extern void __cdecl VMSABS (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDABS (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsabs (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdabs (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAbs (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAbs (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCABS (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl VZABS (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcabs (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzabs (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcAbs (const int n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzAbs (const int n, const MKL_Complex16 a[], double r[]); extern void __cdecl VMCABS (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl VMZABS (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcabs (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl vmzabs (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcAbs (const int n, const MKL_Complex8 a[], float r[], long long int mode); extern void __cdecl vmzAbs (const int n, const MKL_Complex16 a[], double r[], long long int mode); extern void __cdecl VCARG (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl VZARG (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcarg (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzarg (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcArg (const int n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzArg (const int n, const MKL_Complex16 a[], double r[]); extern void __cdecl VMCARG (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl VMZARG (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcarg (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl vmzarg (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcArg (const int n, const MKL_Complex8 a[], float r[], long long int mode); extern void __cdecl vmzArg (const int n, const MKL_Complex16 a[], double r[], long long int mode); extern void __cdecl VSADD (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDADD (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsadd (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdadd (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsAdd (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdAdd (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSADD (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDADD (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsadd (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdadd (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsAdd (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdAdd (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCADD (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZADD (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcadd (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzadd (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcAdd (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzAdd (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCADD (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZADD (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcadd (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzadd (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAdd (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAdd (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSSUB (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDSUB (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vssub (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdsub (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsSub (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdSub (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSSUB (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDSUB (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmssub (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdsub (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsSub (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdSub (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCSUB (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZSUB (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcsub (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzsub (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcSub (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzSub (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCSUB (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSUB (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsub (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsub (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSub (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSub (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSINV (const int *n, const float a[], float r[]); extern void __cdecl VDINV (const int *n, const double a[], double r[]); extern void __cdecl vsinv (const int *n, const float a[], float r[]); extern void __cdecl vdinv (const int *n, const double a[], double r[]); extern void __cdecl vsInv (const int n, const float a[], float r[]); extern void __cdecl vdInv (const int n, const double a[], double r[]); extern void __cdecl VMSINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsinv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdinv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSQRT (const int *n, const float a[], float r[]); extern void __cdecl VDSQRT (const int *n, const double a[], double r[]); extern void __cdecl vssqrt (const int *n, const float a[], float r[]); extern void __cdecl vdsqrt (const int *n, const double a[], double r[]); extern void __cdecl vsSqrt (const int n, const float a[], float r[]); extern void __cdecl vdSqrt (const int n, const double a[], double r[]); extern void __cdecl VMSSQRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSQRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssqrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsqrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSqrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSqrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCSQRT (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZSQRT (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcsqrt (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzsqrt (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcSqrt (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzSqrt (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCSQRT (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSQRT (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsqrt (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsqrt (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSqrt (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSqrt (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSINVSQRT (const int *n, const float a[], float r[]); extern void __cdecl VDINVSQRT (const int *n, const double a[], double r[]); extern void __cdecl vsinvsqrt (const int *n, const float a[], float r[]); extern void __cdecl vdinvsqrt (const int *n, const double a[], double r[]); extern void __cdecl vsInvSqrt (const int n, const float a[], float r[]); extern void __cdecl vdInvSqrt (const int n, const double a[], double r[]); extern void __cdecl VMSINVSQRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDINVSQRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsinvsqrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdinvsqrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsInvSqrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdInvSqrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCBRT (const int *n, const float a[], float r[]); extern void __cdecl VDCBRT (const int *n, const double a[], double r[]); extern void __cdecl vscbrt (const int *n, const float a[], float r[]); extern void __cdecl vdcbrt (const int *n, const double a[], double r[]); extern void __cdecl vsCbrt (const int n, const float a[], float r[]); extern void __cdecl vdCbrt (const int n, const double a[], double r[]); extern void __cdecl VMSCBRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCBRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscbrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcbrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCbrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCbrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSINVCBRT (const int *n, const float a[], float r[]); extern void __cdecl VDINVCBRT (const int *n, const double a[], double r[]); extern void __cdecl vsinvcbrt (const int *n, const float a[], float r[]); extern void __cdecl vdinvcbrt (const int *n, const double a[], double r[]); extern void __cdecl vsInvCbrt (const int n, const float a[], float r[]); extern void __cdecl vdInvCbrt (const int n, const double a[], double r[]); extern void __cdecl VMSINVCBRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDINVCBRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsinvcbrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdinvcbrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsInvCbrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdInvCbrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSQR (const int *n, const float a[], float r[]); extern void __cdecl VDSQR (const int *n, const double a[], double r[]); extern void __cdecl vssqr (const int *n, const float a[], float r[]); extern void __cdecl vdsqr (const int *n, const double a[], double r[]); extern void __cdecl vsSqr (const int n, const float a[], float r[]); extern void __cdecl vdSqr (const int n, const double a[], double r[]); extern void __cdecl VMSSQR (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSQR (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssqr (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsqr (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSqr (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSqr (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSEXP (const int *n, const float a[], float r[]); extern void __cdecl VDEXP (const int *n, const double a[], double r[]); extern void __cdecl vsexp (const int *n, const float a[], float r[]); extern void __cdecl vdexp (const int *n, const double a[], double r[]); extern void __cdecl vsExp (const int n, const float a[], float r[]); extern void __cdecl vdExp (const int n, const double a[], double r[]); extern void __cdecl VMSEXP (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXP (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexp (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexp (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExp (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExp (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCEXP (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZEXP (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcexp (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzexp (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcExp (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzExp (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCEXP (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZEXP (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcexp (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzexp (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcExp (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzExp (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSEXP2 (const int *n, const float a[], float r[]); extern void __cdecl VDEXP2 (const int *n, const double a[], double r[]); extern void __cdecl vsexp2 (const int *n, const float a[], float r[]); extern void __cdecl vdexp2 (const int *n, const double a[], double r[]); extern void __cdecl vsExp2 (const int n, const float a[], float r[]); extern void __cdecl vdExp2 (const int n, const double a[], double r[]); extern void __cdecl VMSEXP2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXP2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexp2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexp2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExp2 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExp2 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSEXP10 (const int *n, const float a[], float r[]); extern void __cdecl VDEXP10 (const int *n, const double a[], double r[]); extern void __cdecl vsexp10 (const int *n, const float a[], float r[]); extern void __cdecl vdexp10 (const int *n, const double a[], double r[]); extern void __cdecl vsExp10 (const int n, const float a[], float r[]); extern void __cdecl vdExp10 (const int n, const double a[], double r[]); extern void __cdecl VMSEXP10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXP10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexp10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexp10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExp10 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExp10 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSEXPM1 (const int *n, const float a[], float r[]); extern void __cdecl VDEXPM1 (const int *n, const double a[], double r[]); extern void __cdecl vsexpm1 (const int *n, const float a[], float r[]); extern void __cdecl vdexpm1 (const int *n, const double a[], double r[]); extern void __cdecl vsExpm1 (const int n, const float a[], float r[]); extern void __cdecl vdExpm1 (const int n, const double a[], double r[]); extern void __cdecl VMSEXPM1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXPM1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexpm1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexpm1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExpm1 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExpm1 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLN (const int *n, const float a[], float r[]); extern void __cdecl VDLN (const int *n, const double a[], double r[]); extern void __cdecl vsln (const int *n, const float a[], float r[]); extern void __cdecl vdln (const int *n, const double a[], double r[]); extern void __cdecl vsLn (const int n, const float a[], float r[]); extern void __cdecl vdLn (const int n, const double a[], double r[]); extern void __cdecl VMSLN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsln (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdln (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLn (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLn (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCLN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZLN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcln (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzln (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcLn (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzLn (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCLN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZLN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcln (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzln (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcLn (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzLn (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSLOG2 (const int *n, const float a[], float r[]); extern void __cdecl VDLOG2 (const int *n, const double a[], double r[]); extern void __cdecl vslog2 (const int *n, const float a[], float r[]); extern void __cdecl vdlog2 (const int *n, const double a[], double r[]); extern void __cdecl vsLog2 (const int n, const float a[], float r[]); extern void __cdecl vdLog2 (const int n, const double a[], double r[]); extern void __cdecl VMSLOG2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOG2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslog2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlog2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLog2 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLog2 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLOG10 (const int *n, const float a[], float r[]); extern void __cdecl VDLOG10 (const int *n, const double a[], double r[]); extern void __cdecl vslog10 (const int *n, const float a[], float r[]); extern void __cdecl vdlog10 (const int *n, const double a[], double r[]); extern void __cdecl vsLog10 (const int n, const float a[], float r[]); extern void __cdecl vdLog10 (const int n, const double a[], double r[]); extern void __cdecl VMSLOG10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOG10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslog10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlog10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLog10 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLog10 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCLOG10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZLOG10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vclog10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzlog10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcLog10 (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzLog10 (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCLOG10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZLOG10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmclog10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzlog10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcLog10 (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzLog10 (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSLOG1P (const int *n, const float a[], float r[]); extern void __cdecl VDLOG1P (const int *n, const double a[], double r[]); extern void __cdecl vslog1p (const int *n, const float a[], float r[]); extern void __cdecl vdlog1p (const int *n, const double a[], double r[]); extern void __cdecl vsLog1p (const int n, const float a[], float r[]); extern void __cdecl vdLog1p (const int n, const double a[], double r[]); extern void __cdecl VMSLOG1P (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOG1P (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslog1p (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlog1p (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLog1p (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLog1p (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLOGB (const int *n, const float a[], float r[]); extern void __cdecl VDLOGB (const int *n, const double a[], double r[]); extern void __cdecl vslogb (const int *n, const float a[], float r[]); extern void __cdecl vdlogb (const int *n, const double a[], double r[]); extern void __cdecl vsLogb (const int n, const float a[], float r[]); extern void __cdecl vdLogb (const int n, const double a[], double r[]); extern void __cdecl VMSLOGB (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOGB (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslogb (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlogb (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLogb (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLogb (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCOS (const int *n, const float a[], float r[]); extern void __cdecl VDCOS (const int *n, const double a[], double r[]); extern void __cdecl vscos (const int *n, const float a[], float r[]); extern void __cdecl vdcos (const int *n, const double a[], double r[]); extern void __cdecl vsCos (const int n, const float a[], float r[]); extern void __cdecl vdCos (const int n, const double a[], double r[]); extern void __cdecl VMSCOS (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCOS (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscos (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcos (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCos (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCos (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCCOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZCOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vccos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzcos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcCos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzCos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCCOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmccos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzcos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcCos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzCos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSSIN (const int *n, const float a[], float r[]); extern void __cdecl VDSIN (const int *n, const double a[], double r[]); extern void __cdecl vssin (const int *n, const float a[], float r[]); extern void __cdecl vdsin (const int *n, const double a[], double r[]); extern void __cdecl vsSin (const int n, const float a[], float r[]); extern void __cdecl vdSin (const int n, const double a[], double r[]); extern void __cdecl VMSSIN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSIN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssin (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsin (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSin (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSin (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCSIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZSIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcsin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzsin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcSin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzSin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCSIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSTAN (const int *n, const float a[], float r[]); extern void __cdecl VDTAN (const int *n, const double a[], double r[]); extern void __cdecl vstan (const int *n, const float a[], float r[]); extern void __cdecl vdtan (const int *n, const double a[], double r[]); extern void __cdecl vsTan (const int n, const float a[], float r[]); extern void __cdecl vdTan (const int n, const double a[], double r[]); extern void __cdecl VMSTAN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTAN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstan (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtan (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTan (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTan (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCTAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZTAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vctan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vztan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcTan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzTan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCTAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZTAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmctan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmztan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcTan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzTan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSCOSPI (const int *n, const float a[], float r[]); extern void __cdecl VDCOSPI (const int *n, const double a[], double r[]); extern void __cdecl vscospi (const int *n, const float a[], float r[]); extern void __cdecl vdcospi (const int *n, const double a[], double r[]); extern void __cdecl vsCospi (const int n, const float a[], float r[]); extern void __cdecl vdCospi (const int n, const double a[], double r[]); extern void __cdecl VMSCOSPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscospi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCospi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCospi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSINPI (const int *n, const float a[], float r[]); extern void __cdecl VDSINPI (const int *n, const double a[], double r[]); extern void __cdecl vssinpi (const int *n, const float a[], float r[]); extern void __cdecl vdsinpi (const int *n, const double a[], double r[]); extern void __cdecl vsSinpi (const int n, const float a[], float r[]); extern void __cdecl vdSinpi (const int n, const double a[], double r[]); extern void __cdecl VMSSINPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssinpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSinpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSinpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTANPI (const int *n, const float a[], float r[]); extern void __cdecl VDTANPI (const int *n, const double a[], double r[]); extern void __cdecl vstanpi (const int *n, const float a[], float r[]); extern void __cdecl vdtanpi (const int *n, const double a[], double r[]); extern void __cdecl vsTanpi (const int n, const float a[], float r[]); extern void __cdecl vdTanpi (const int n, const double a[], double r[]); extern void __cdecl VMSTANPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstanpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTanpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTanpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCOSD (const int *n, const float a[], float r[]); extern void __cdecl VDCOSD (const int *n, const double a[], double r[]); extern void __cdecl vscosd (const int *n, const float a[], float r[]); extern void __cdecl vdcosd (const int *n, const double a[], double r[]); extern void __cdecl vsCosd (const int n, const float a[], float r[]); extern void __cdecl vdCosd (const int n, const double a[], double r[]); extern void __cdecl VMSCOSD (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCosd (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscosd (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcosd (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCosd (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCosd (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSIND (const int *n, const float a[], float r[]); extern void __cdecl VDSIND (const int *n, const double a[], double r[]); extern void __cdecl vssind (const int *n, const float a[], float r[]); extern void __cdecl vdsind (const int *n, const double a[], double r[]); extern void __cdecl vsSind (const int n, const float a[], float r[]); extern void __cdecl vdSind (const int n, const double a[], double r[]); extern void __cdecl VMSSIND (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSind (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssind (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsind (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSind (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSind (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTAND (const int *n, const float a[], float r[]); extern void __cdecl VDTAND (const int *n, const double a[], double r[]); extern void __cdecl vstand (const int *n, const float a[], float r[]); extern void __cdecl vdtand (const int *n, const double a[], double r[]); extern void __cdecl vsTand (const int n, const float a[], float r[]); extern void __cdecl vdTand (const int n, const double a[], double r[]); extern void __cdecl VMSTAND (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTand (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstand (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtand (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTand (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTand (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCOSH (const int *n, const float a[], float r[]); extern void __cdecl VDCOSH (const int *n, const double a[], double r[]); extern void __cdecl vscosh (const int *n, const float a[], float r[]); extern void __cdecl vdcosh (const int *n, const double a[], double r[]); extern void __cdecl vsCosh (const int n, const float a[], float r[]); extern void __cdecl vdCosh (const int n, const double a[], double r[]); extern void __cdecl VMSCOSH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCOSH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscosh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcosh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCosh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCosh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCCOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZCOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vccosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzcosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcCosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzCosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCCOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmccosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzcosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcCosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzCosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSSINH (const int *n, const float a[], float r[]); extern void __cdecl VDSINH (const int *n, const double a[], double r[]); extern void __cdecl vssinh (const int *n, const float a[], float r[]); extern void __cdecl vdsinh (const int *n, const double a[], double r[]); extern void __cdecl vsSinh (const int n, const float a[], float r[]); extern void __cdecl vdSinh (const int n, const double a[], double r[]); extern void __cdecl VMSSINH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSINH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssinh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsinh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSinh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSinh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCSINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZSINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcsinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzsinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcSinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzSinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCSINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSTANH (const int *n, const float a[], float r[]); extern void __cdecl VDTANH (const int *n, const double a[], double r[]); extern void __cdecl vstanh (const int *n, const float a[], float r[]); extern void __cdecl vdtanh (const int *n, const double a[], double r[]); extern void __cdecl vsTanh (const int n, const float a[], float r[]); extern void __cdecl vdTanh (const int n, const double a[], double r[]); extern void __cdecl VMSTANH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTANH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstanh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtanh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTanh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTanh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCTANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZTANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vctanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vztanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcTanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzTanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCTANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZTANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmctanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmztanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcTanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzTanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSACOS (const int *n, const float a[], float r[]); extern void __cdecl VDACOS (const int *n, const double a[], double r[]); extern void __cdecl vsacos (const int *n, const float a[], float r[]); extern void __cdecl vdacos (const int *n, const double a[], double r[]); extern void __cdecl vsAcos (const int n, const float a[], float r[]); extern void __cdecl vdAcos (const int n, const double a[], double r[]); extern void __cdecl VMSACOS (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDACOS (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsacos (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdacos (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAcos (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAcos (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCACOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZACOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcacos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzacos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAcos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAcos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCACOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZACOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcacos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzacos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAcos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAcos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSASIN (const int *n, const float a[], float r[]); extern void __cdecl VDASIN (const int *n, const double a[], double r[]); extern void __cdecl vsasin (const int *n, const float a[], float r[]); extern void __cdecl vdasin (const int *n, const double a[], double r[]); extern void __cdecl vsAsin (const int n, const float a[], float r[]); extern void __cdecl vdAsin (const int n, const double a[], double r[]); extern void __cdecl VMSASIN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDASIN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsasin (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdasin (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAsin (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAsin (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCASIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZASIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcasin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzasin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAsin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAsin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCASIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZASIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcasin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzasin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAsin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAsin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSATAN (const int *n, const float a[], float r[]); extern void __cdecl VDATAN (const int *n, const double a[], double r[]); extern void __cdecl vsatan (const int *n, const float a[], float r[]); extern void __cdecl vdatan (const int *n, const double a[], double r[]); extern void __cdecl vsAtan (const int n, const float a[], float r[]); extern void __cdecl vdAtan (const int n, const double a[], double r[]); extern void __cdecl VMSATAN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDATAN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsatan (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdatan (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAtan (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAtan (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCATAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZATAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcatan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzatan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAtan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAtan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCATAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZATAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcatan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzatan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAtan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAtan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSACOSPI (const int *n, const float a[], float r[]); extern void __cdecl VDACOSPI (const int *n, const double a[], double r[]); extern void __cdecl vsacospi (const int *n, const float a[], float r[]); extern void __cdecl vdacospi (const int *n, const double a[], double r[]); extern void __cdecl vsAcospi (const int n, const float a[], float r[]); extern void __cdecl vdAcospi (const int n, const double a[], double r[]); extern void __cdecl VMSACOSPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDAcospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsacospi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdacospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAcospi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAcospi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSASINPI (const int *n, const float a[], float r[]); extern void __cdecl VDASINPI (const int *n, const double a[], double r[]); extern void __cdecl vsasinpi (const int *n, const float a[], float r[]); extern void __cdecl vdasinpi (const int *n, const double a[], double r[]); extern void __cdecl vsAsinpi (const int n, const float a[], float r[]); extern void __cdecl vdAsinpi (const int n, const double a[], double r[]); extern void __cdecl VMSASINPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDAsinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsasinpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdasinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAsinpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAsinpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSATANPI (const int *n, const float a[], float r[]); extern void __cdecl VDATANPI (const int *n, const double a[], double r[]); extern void __cdecl vsatanpi (const int *n, const float a[], float r[]); extern void __cdecl vdatanpi (const int *n, const double a[], double r[]); extern void __cdecl vsAtanpi (const int n, const float a[], float r[]); extern void __cdecl vdAtanpi (const int n, const double a[], double r[]); extern void __cdecl VMSATANPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDAtanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsatanpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdatanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAtanpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAtanpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSACOSH (const int *n, const float a[], float r[]); extern void __cdecl VDACOSH (const int *n, const double a[], double r[]); extern void __cdecl vsacosh (const int *n, const float a[], float r[]); extern void __cdecl vdacosh (const int *n, const double a[], double r[]); extern void __cdecl vsAcosh (const int n, const float a[], float r[]); extern void __cdecl vdAcosh (const int n, const double a[], double r[]); extern void __cdecl VMSACOSH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDACOSH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsacosh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdacosh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAcosh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAcosh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCACOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZACOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcacosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzacosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAcosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAcosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCACOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZACOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcacosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzacosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAcosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAcosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSASINH (const int *n, const float a[], float r[]); extern void __cdecl VDASINH (const int *n, const double a[], double r[]); extern void __cdecl vsasinh (const int *n, const float a[], float r[]); extern void __cdecl vdasinh (const int *n, const double a[], double r[]); extern void __cdecl vsAsinh (const int n, const float a[], float r[]); extern void __cdecl vdAsinh (const int n, const double a[], double r[]); extern void __cdecl VMSASINH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDASINH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsasinh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdasinh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAsinh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAsinh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCASINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZASINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcasinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzasinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAsinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAsinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCASINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZASINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcasinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzasinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAsinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAsinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSATANH (const int *n, const float a[], float r[]); extern void __cdecl VDATANH (const int *n, const double a[], double r[]); extern void __cdecl vsatanh (const int *n, const float a[], float r[]); extern void __cdecl vdatanh (const int *n, const double a[], double r[]); extern void __cdecl vsAtanh (const int n, const float a[], float r[]); extern void __cdecl vdAtanh (const int n, const double a[], double r[]); extern void __cdecl VMSATANH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDATANH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsatanh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdatanh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAtanh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAtanh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCATANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZATANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcatanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzatanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAtanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAtanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCATANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZATANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcatanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzatanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAtanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAtanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSERF (const int *n, const float a[], float r[]); extern void __cdecl VDERF (const int *n, const double a[], double r[]); extern void __cdecl vserf (const int *n, const float a[], float r[]); extern void __cdecl vderf (const int *n, const double a[], double r[]); extern void __cdecl vsErf (const int n, const float a[], float r[]); extern void __cdecl vdErf (const int n, const double a[], double r[]); extern void __cdecl VMSERF (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERF (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserf (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderf (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErf (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErf (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSERFINV (const int *n, const float a[], float r[]); extern void __cdecl VDERFINV (const int *n, const double a[], double r[]); extern void __cdecl vserfinv (const int *n, const float a[], float r[]); extern void __cdecl vderfinv (const int *n, const double a[], double r[]); extern void __cdecl vsErfInv (const int n, const float a[], float r[]); extern void __cdecl vdErfInv (const int n, const double a[], double r[]); extern void __cdecl VMSERFINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERFINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserfinv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderfinv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErfInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErfInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSHYPOT (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDHYPOT (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vshypot (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdhypot (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsHypot (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdHypot (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSHYPOT (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDHYPOT (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmshypot (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdhypot (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsHypot (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdHypot (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSERFC (const int *n, const float a[], float r[]); extern void __cdecl VDERFC (const int *n, const double a[], double r[]); extern void __cdecl vserfc (const int *n, const float a[], float r[]); extern void __cdecl vderfc (const int *n, const double a[], double r[]); extern void __cdecl vsErfc (const int n, const float a[], float r[]); extern void __cdecl vdErfc (const int n, const double a[], double r[]); extern void __cdecl VMSERFC (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERFC (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserfc (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderfc (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErfc (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErfc (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSERFCINV (const int *n, const float a[], float r[]); extern void __cdecl VDERFCINV (const int *n, const double a[], double r[]); extern void __cdecl vserfcinv (const int *n, const float a[], float r[]); extern void __cdecl vderfcinv (const int *n, const double a[], double r[]); extern void __cdecl vsErfcInv (const int n, const float a[], float r[]); extern void __cdecl vdErfcInv (const int n, const double a[], double r[]); extern void __cdecl VMSERFCINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERFCINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserfcinv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderfcinv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErfcInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErfcInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCDFNORM (const int *n, const float a[], float r[]); extern void __cdecl VDCDFNORM (const int *n, const double a[], double r[]); extern void __cdecl vscdfnorm (const int *n, const float a[], float r[]); extern void __cdecl vdcdfnorm (const int *n, const double a[], double r[]); extern void __cdecl vsCdfNorm (const int n, const float a[], float r[]); extern void __cdecl vdCdfNorm (const int n, const double a[], double r[]); extern void __cdecl VMSCDFNORM (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCDFNORM (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscdfnorm (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcdfnorm (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCdfNorm (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCdfNorm (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCDFNORMINV (const int *n, const float a[], float r[]); extern void __cdecl VDCDFNORMINV (const int *n, const double a[], double r[]); extern void __cdecl vscdfnorminv (const int *n, const float a[], float r[]); extern void __cdecl vdcdfnorminv (const int *n, const double a[], double r[]); extern void __cdecl vsCdfNormInv (const int n, const float a[], float r[]); extern void __cdecl vdCdfNormInv (const int n, const double a[], double r[]); extern void __cdecl VMSCDFNORMINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCDFNORMINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscdfnorminv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcdfnorminv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCdfNormInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCdfNormInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLGAMMA (const int *n, const float a[], float r[]); extern void __cdecl VDLGAMMA (const int *n, const double a[], double r[]); extern void __cdecl vslgamma (const int *n, const float a[], float r[]); extern void __cdecl vdlgamma (const int *n, const double a[], double r[]); extern void __cdecl vsLGamma (const int n, const float a[], float r[]); extern void __cdecl vdLGamma (const int n, const double a[], double r[]); extern void __cdecl VMSLGAMMA (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLGAMMA (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslgamma (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlgamma (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLGamma (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLGamma (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTGAMMA (const int *n, const float a[], float r[]); extern void __cdecl VDTGAMMA (const int *n, const double a[], double r[]); extern void __cdecl vstgamma (const int *n, const float a[], float r[]); extern void __cdecl vdtgamma (const int *n, const double a[], double r[]); extern void __cdecl vsTGamma (const int n, const float a[], float r[]); extern void __cdecl vdTGamma (const int n, const double a[], double r[]); extern void __cdecl VMSTGAMMA (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTGAMMA (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstgamma (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtgamma (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTGamma (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTGamma (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSATAN2 (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDATAN2 (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsatan2 (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdatan2 (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsAtan2 (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdAtan2 (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSATAN2 (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDATAN2 (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsatan2 (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdatan2 (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsAtan2 (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdAtan2 (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSATAN2PI (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDATAN2PI (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsatan2pi (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdatan2pi (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsAtan2pi (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdAtan2pi (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSATAN2PI (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDATAN2PI (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsatan2pi (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdatan2pi (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsAtan2pi (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdAtan2pi (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSMUL (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDMUL (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsmul (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdmul (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsMul (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdMul (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSMUL (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDMUL (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsmul (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdmul (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsMul (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdMul (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCMUL (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZMUL (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcmul (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzmul (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcMul (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzMul (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCMUL (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZMUL (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcmul (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzmul (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcMul (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzMul (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSDIV (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDDIV (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsdiv (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vddiv (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsDiv (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdDiv (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSDIV (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDDIV (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsdiv (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmddiv (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsDiv (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdDiv (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCDIV (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZDIV (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcdiv (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzdiv (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcDiv (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzDiv (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCDIV (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZDIV (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcdiv (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzdiv (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcDiv (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzDiv (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSPOW (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDPOW (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vspow (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdpow (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsPow (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdPow (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSPOW (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDPOW (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmspow (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdpow (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsPow (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdPow (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCPOW (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZPOW (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcpow (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzpow (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcPow (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzPow (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCPOW (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZPOW (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcpow (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzpow (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcPow (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzPow (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSPOW3O2 (const int *n, const float a[], float r[]); extern void __cdecl VDPOW3O2 (const int *n, const double a[], double r[]); extern void __cdecl vspow3o2 (const int *n, const float a[], float r[]); extern void __cdecl vdpow3o2 (const int *n, const double a[], double r[]); extern void __cdecl vsPow3o2 (const int n, const float a[], float r[]); extern void __cdecl vdPow3o2 (const int n, const double a[], double r[]); extern void __cdecl VMSPOW3O2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDPOW3O2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmspow3o2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdpow3o2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsPow3o2 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdPow3o2 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSPOW2O3 (const int *n, const float a[], float r[]); extern void __cdecl VDPOW2O3 (const int *n, const double a[], double r[]); extern void __cdecl vspow2o3 (const int *n, const float a[], float r[]); extern void __cdecl vdpow2o3 (const int *n, const double a[], double r[]); extern void __cdecl vsPow2o3 (const int n, const float a[], float r[]); extern void __cdecl vdPow2o3 (const int n, const double a[], double r[]); extern void __cdecl VMSPOW2O3 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDPOW2O3 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmspow2o3 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdpow2o3 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsPow2o3 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdPow2o3 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSPOWX (const int *n, const float a[], const float *b, float r[]); extern void __cdecl VDPOWX (const int *n, const double a[], const double *b, double r[]); extern void __cdecl vspowx (const int *n, const float a[], const float *b, float r[]); extern void __cdecl vdpowx (const int *n, const double a[], const double *b, double r[]); extern void __cdecl vsPowx (const int n, const float a[], const float b, float r[]); extern void __cdecl vdPowx (const int n, const double a[], const double b, double r[]); extern void __cdecl VMSPOWX (const int *n, const float a[], const float *b, float r[], long long int *mode); extern void __cdecl VMDPOWX (const int *n, const double a[], const double *b, double r[], long long int *mode); extern void __cdecl vmspowx (const int *n, const float a[], const float *b, float r[], long long int *mode); extern void __cdecl vmdpowx (const int *n, const double a[], const double *b, double r[], long long int *mode); extern void __cdecl vmsPowx (const int n, const float a[], const float b, float r[], long long int mode); extern void __cdecl vmdPowx (const int n, const double a[], const double b, double r[], long long int mode); extern void __cdecl VCPOWX (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[]); extern void __cdecl VZPOWX (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[]); extern void __cdecl vcpowx (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[]); extern void __cdecl vzpowx (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[]); extern void __cdecl vcPowx (const int n, const MKL_Complex8 a[], const MKL_Complex8 b, MKL_Complex8 r[]); extern void __cdecl vzPowx (const int n, const MKL_Complex16 a[], const MKL_Complex16 b, MKL_Complex16 r[]); extern void __cdecl VMCPOWX (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZPOWX (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcpowx (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzpowx (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcPowx (const int n, const MKL_Complex8 a[], const MKL_Complex8 b, MKL_Complex8 r[], long long int mode); extern void __cdecl vmzPowx (const int n, const MKL_Complex16 a[], const MKL_Complex16 b, MKL_Complex16 r[], long long int mode); extern void __cdecl VSPOWR (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDPOWR (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vspowr (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdpowr (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsPowr (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdPowr (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSPOWR (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDPOWR (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmspowr (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdpowr (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsPowr (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdPowr (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSSINCOS (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDSINCOS (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vssincos (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdsincos (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsSinCos (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdSinCos (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSSINCOS (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDSINCOS (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmssincos (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdsincos (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsSinCos (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdSinCos (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSLINEARFRAC (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[]); extern void __cdecl VDLINEARFRAC (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[]); extern void __cdecl vslinearfrac (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[]); extern void __cdecl vdlinearfrac (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[]); extern void __cdecl vsLinearFrac (const int n, const float a[], const float b[], const float scalea, const float shifta, const float scaleb, const float shiftb, float r[]); extern void __cdecl vdLinearFrac (const int n, const double a[], const double b[], const double scalea, const double shifta, const double scaleb, const double shiftb, double r[]); extern void __cdecl VMSLINEARFRAC (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[], long long int *mode); extern void __cdecl VMDLINEARFRAC (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[], long long int *mode); extern void __cdecl vmslinearfrac (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[], long long int *mode); extern void __cdecl vmdlinearfrac (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[], long long int *mode); extern void __cdecl vmsLinearFrac (const int n, const float a[], const float b[], const float scalea, const float shifta, const float scaleb, const float shiftb, float r[], long long int mode); extern void __cdecl vmdLinearFrac (const int n, const double a[], const double b[], const double scalea, const double shifta, const double scaleb, const double shiftb, double r[], long long int mode); extern void __cdecl VSCEIL (const int *n, const float a[], float r[]); extern void __cdecl VDCEIL (const int *n, const double a[], double r[]); extern void __cdecl vsceil (const int *n, const float a[], float r[]); extern void __cdecl vdceil (const int *n, const double a[], double r[]); extern void __cdecl vsCeil (const int n, const float a[], float r[]); extern void __cdecl vdCeil (const int n, const double a[], double r[]); extern void __cdecl VMSCEIL (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCEIL (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsceil (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdceil (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCeil (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCeil (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSFLOOR (const int *n, const float a[], float r[]); extern void __cdecl VDFLOOR (const int *n, const double a[], double r[]); extern void __cdecl vsfloor (const int *n, const float a[], float r[]); extern void __cdecl vdfloor (const int *n, const double a[], double r[]); extern void __cdecl vsFloor (const int n, const float a[], float r[]); extern void __cdecl vdFloor (const int n, const double a[], double r[]); extern void __cdecl VMSFLOOR (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDFLOOR (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsfloor (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdfloor (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsFloor (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdFloor (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSFRAC (const int *n, const float a[], float r[]); extern void __cdecl VDFRAC (const int *n, const double a[], double r[]); extern void __cdecl vsfrac (const int *n, const float a[], float r[]); extern void __cdecl vdfrac (const int *n, const double a[], double r[]); extern void __cdecl vsFrac (const int n, const float a[], float r[]); extern void __cdecl vdFrac (const int n, const double a[], double r[]); extern void __cdecl VMSFRAC (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDFRAC (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsfrac (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdfrac (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsFrac (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdFrac (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSMODF (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDMODF (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsmodf (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdmodf (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsModf (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdModf (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSMODF (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDMODF (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsmodf (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdmodf (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsModf (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdModf (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFMOD (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFMOD (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfmod (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfmod (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFmod (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFmod (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFMOD (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFMOD (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfmod (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfmod (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFmod (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFmod (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSREMAINDER (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDREMAINDER (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsremainder (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdremainder (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsRemainder (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdRemainder (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSREMAINDER (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDREMAINDER (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsremainder (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdremainder (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsRemainder (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdRemainder (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSNEXTAFTER (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDNEXTAFTER (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsnextafter (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdnextafter (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsNextAfter (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdNextAfter (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSNEXTAFTER (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDNEXTAFTER (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsnextafter (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdnextafter (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsNextAfter (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdNextAfter (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSCOPYSIGN (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDCOPYSIGN (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vscopysign (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdcopysign (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsCopySign (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdCopySign (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSCOPYSIGN (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDCOPYSIGN (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmscopysign (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdcopysign (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsCopySign (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdCopySign (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFDIM (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFDIM (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfdim (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfdim (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFdim (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFdim (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFDIM (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFDIM (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfdim (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfdim (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFdim (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFdim (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFMAX (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFMAX (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfmax (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfmax (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFmax (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFmax (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFMAX (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFMAX (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfmax (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfmax (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFmax (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFmax (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFMIN (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFMIN (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfmin (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfmin (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFmin (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFmin (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFMIN (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFMIN (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfmin (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfmin (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFmin (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFmin (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSMAXMAG (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDMAXMAG (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsmaxmag (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdmaxmag (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsMaxMag (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdMaxMag (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSMAXMAG (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDMAXMAG (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsmaxmag (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdmaxmag (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsMaxMag (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdMaxMag (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSMINMAG (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDMINMAG (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsminmag (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdminmag (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsMinMag (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdMinMag (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSMINMAG (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDMINMAG (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsminmag (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdminmag (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsMinMag (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdMinMag (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSNEARBYINT (const int *n, const float a[], float r[]); extern void __cdecl VDNEARBYINT (const int *n, const double a[], double r[]); extern void __cdecl vsnearbyint (const int *n, const float a[], float r[]); extern void __cdecl vdnearbyint (const int *n, const double a[], double r[]); extern void __cdecl vsNearbyInt (const int n, const float a[], float r[]); extern void __cdecl vdNearbyInt (const int n, const double a[], double r[]); extern void __cdecl VMSNEARBYINT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDNEARBYINT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsnearbyint (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdnearbyint (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsNearbyInt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdNearbyInt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSRINT (const int *n, const float a[], float r[]); extern void __cdecl VDRINT (const int *n, const double a[], double r[]); extern void __cdecl vsrint (const int *n, const float a[], float r[]); extern void __cdecl vdrint (const int *n, const double a[], double r[]); extern void __cdecl vsRint (const int n, const float a[], float r[]); extern void __cdecl vdRint (const int n, const double a[], double r[]); extern void __cdecl VMSRINT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDRINT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsrint (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdrint (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsRint (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdRint (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSROUND (const int *n, const float a[], float r[]); extern void __cdecl VDROUND (const int *n, const double a[], double r[]); extern void __cdecl vsround (const int *n, const float a[], float r[]); extern void __cdecl vdround (const int *n, const double a[], double r[]); extern void __cdecl vsRound (const int n, const float a[], float r[]); extern void __cdecl vdRound (const int n, const double a[], double r[]); extern void __cdecl VMSROUND (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDROUND (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsround (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdround (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsRound (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdRound (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTRUNC (const int *n, const float a[], float r[]); extern void __cdecl VDTRUNC (const int *n, const double a[], double r[]); extern void __cdecl vstrunc (const int *n, const float a[], float r[]); extern void __cdecl vdtrunc (const int *n, const double a[], double r[]); extern void __cdecl vsTrunc (const int n, const float a[], float r[]); extern void __cdecl vdTrunc (const int n, const double a[], double r[]); extern void __cdecl VMSTRUNC (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTRUNC (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstrunc (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtrunc (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTrunc (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTrunc (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCCONJ (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZCONJ (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcconj (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzconj (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcConj (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzConj (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCCONJ (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCONJ (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcconj (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzconj (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcConj (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzConj (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VCMULBYCONJ (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZMULBYCONJ (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcmulbyconj (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzmulbyconj (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcMulByConj (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzMulByConj (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCMULBYCONJ (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZMULBYCONJ (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcmulbyconj (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzmulbyconj (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcMulByConj (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzMulByConj (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VCCIS (const int *n, const float a[], MKL_Complex8 r[]); extern void __cdecl VZCIS (const int *n, const double a[], MKL_Complex16 r[]); extern void __cdecl vccis (const int *n, const float a[], MKL_Complex8 r[]); extern void __cdecl vzcis (const int *n, const double a[], MKL_Complex16 r[]); extern void __cdecl vcCIS (const int n, const float a[], MKL_Complex8 r[]); extern void __cdecl vzCIS (const int n, const double a[], MKL_Complex16 r[]); extern void __cdecl VMCCIS (const int *n, const float a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCIS (const int *n, const double a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmccis (const int *n, const float a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzcis (const int *n, const double a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcCIS (const int n, const float a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzCIS (const int n, const double a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSEXPINT1 (const int *n, const float a[], float r[]); extern void __cdecl VDEXPINT1 (const int *n, const double a[], double r[]); extern void __cdecl vsexpint1 (const int *n, const float a[], float r[]); extern void __cdecl vdexpint1 (const int *n, const double a[], double r[]); extern void __cdecl vsExpInt1 (const int n, const float a[], float r[]); extern void __cdecl vdExpInt1 (const int n, const double a[], double r[]); extern void __cdecl VMSEXPINT1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXPINT1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexpint1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexpint1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExpInt1 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExpInt1 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSPACKI (const int *n, const float a[], const int * incra, float y[]); extern void __cdecl VDPACKI (const int *n, const double a[], const int * incra, double y[]); extern void __cdecl vspacki (const int *n, const float a[], const int * incra, float y[]); extern void __cdecl vdpacki (const int *n, const double a[], const int * incra, double y[]); extern void __cdecl vsPackI (const int n, const float a[], const int incra, float y[]); extern void __cdecl vdPackI (const int n, const double a[], const int incra, double y[]); extern void __cdecl VCPACKI (const int *n, const MKL_Complex8 a[], const int * incra, MKL_Complex8 y[]); extern void __cdecl VZPACKI (const int *n, const MKL_Complex16 a[], const int * incra, MKL_Complex16 y[]); extern void __cdecl vcpacki (const int *n, const MKL_Complex8 a[], const int * incra, MKL_Complex8 y[]); extern void __cdecl vzpacki (const int *n, const MKL_Complex16 a[], const int * incra, MKL_Complex16 y[]); extern void __cdecl vcPackI (const int n, const MKL_Complex8 a[], const int incra, MKL_Complex8 y[]); extern void __cdecl vzPackI (const int n, const MKL_Complex16 a[], const int incra, MKL_Complex16 y[]); extern void __cdecl VSPACKV (const int *n, const float a[], const int ia[], float y[]); extern void __cdecl VDPACKV (const int *n, const double a[], const int ia[], double y[]); extern void __cdecl vspackv (const int *n, const float a[], const int ia[], float y[]); extern void __cdecl vdpackv (const int *n, const double a[], const int ia[], double y[]); extern void __cdecl vsPackV (const int n, const float a[], const int ia[], float y[]); extern void __cdecl vdPackV (const int n, const double a[], const int ia[], double y[]); extern void __cdecl VCPACKV (const int *n, const MKL_Complex8 a[], const int ia[], MKL_Complex8 y[]); extern void __cdecl VZPACKV (const int *n, const MKL_Complex16 a[], const int ia[], MKL_Complex16 y[]); extern void __cdecl vcpackv (const int *n, const MKL_Complex8 a[], const int ia[], MKL_Complex8 y[]); extern void __cdecl vzpackv (const int *n, const MKL_Complex16 a[], const int ia[], MKL_Complex16 y[]); extern void __cdecl vcPackV (const int n, const MKL_Complex8 a[], const int ia[], MKL_Complex8 y[]); extern void __cdecl vzPackV (const int n, const MKL_Complex16 a[], const int ia[], MKL_Complex16 y[]); extern void __cdecl VSPACKM (const int *n, const float a[], const int ma[], float y[]); extern void __cdecl VDPACKM (const int *n, const double a[], const int ma[], double y[]); extern void __cdecl vspackm (const int *n, const float a[], const int ma[], float y[]); extern void __cdecl vdpackm (const int *n, const double a[], const int ma[], double y[]); extern void __cdecl vsPackM (const int n, const float a[], const int ma[], float y[]); extern void __cdecl vdPackM (const int n, const double a[], const int ma[], double y[]); extern void __cdecl VCPACKM (const int *n, const MKL_Complex8 a[], const int ma[], MKL_Complex8 y[]); extern void __cdecl VZPACKM (const int *n, const MKL_Complex16 a[], const int ma[], MKL_Complex16 y[]); extern void __cdecl vcpackm (const int *n, const MKL_Complex8 a[], const int ma[], MKL_Complex8 y[]); extern void __cdecl vzpackm (const int *n, const MKL_Complex16 a[], const int ma[], MKL_Complex16 y[]); extern void __cdecl vcPackM (const int n, const MKL_Complex8 a[], const int ma[], MKL_Complex8 y[]); extern void __cdecl vzPackM (const int n, const MKL_Complex16 a[], const int ma[], MKL_Complex16 y[]); extern void __cdecl VSUNPACKI (const int *n, const float a[], float y[], const int * incry); extern void __cdecl VDUNPACKI (const int *n, const double a[], double y[], const int * incry); extern void __cdecl vsunpacki (const int *n, const float a[], float y[], const int * incry); extern void __cdecl vdunpacki (const int *n, const double a[], double y[], const int * incry); extern void __cdecl vsUnpackI (const int n, const float a[], float y[], const int incry ); extern void __cdecl vdUnpackI (const int n, const double a[], double y[], const int incry ); extern void __cdecl VCUNPACKI (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int * incry); extern void __cdecl VZUNPACKI (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int * incry); extern void __cdecl vcunpacki (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int * incry); extern void __cdecl vzunpacki (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int * incry); extern void __cdecl vcUnpackI (const int n, const MKL_Complex8 a[], MKL_Complex8 y[], const int incry ); extern void __cdecl vzUnpackI (const int n, const MKL_Complex16 a[], MKL_Complex16 y[], const int incry ); extern void __cdecl VSUNPACKV (const int *n, const float a[], float y[], const int iy[] ); extern void __cdecl VDUNPACKV (const int *n, const double a[], double y[], const int iy[] ); extern void __cdecl vsunpackv (const int *n, const float a[], float y[], const int iy[] ); extern void __cdecl vdunpackv (const int *n, const double a[], double y[], const int iy[] ); extern void __cdecl vsUnpackV (const int n, const float a[], float y[], const int iy[] ); extern void __cdecl vdUnpackV (const int n, const double a[], double y[], const int iy[] ); extern void __cdecl VCUNPACKV (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int iy[]); extern void __cdecl VZUNPACKV (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int iy[]); extern void __cdecl vcunpackv (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int iy[]); extern void __cdecl vzunpackv (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int iy[]); extern void __cdecl vcUnpackV (const int n, const MKL_Complex8 a[], MKL_Complex8 y[], const int iy[]); extern void __cdecl vzUnpackV (const int n, const MKL_Complex16 a[], MKL_Complex16 y[], const int iy[]); extern void __cdecl VSUNPACKM (const int *n, const float a[], float y[], const int my[] ); extern void __cdecl VDUNPACKM (const int *n, const double a[], double y[], const int my[] ); extern void __cdecl vsunpackm (const int *n, const float a[], float y[], const int my[] ); extern void __cdecl vdunpackm (const int *n, const double a[], double y[], const int my[] ); extern void __cdecl vsUnpackM (const int n, const float a[], float y[], const int my[] ); extern void __cdecl vdUnpackM (const int n, const double a[], double y[], const int my[] ); extern void __cdecl VCUNPACKM (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int my[]); extern void __cdecl VZUNPACKM (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int my[]); extern void __cdecl vcunpackm (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int my[]); extern void __cdecl vzunpackm (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int my[]); extern void __cdecl vcUnpackM (const int n, const MKL_Complex8 a[], MKL_Complex8 y[], const int my[]); extern void __cdecl vzUnpackM (const int n, const MKL_Complex16 a[], MKL_Complex16 y[], const int my[]); extern int __cdecl VMLSETERRSTATUS (const int * status); extern int __cdecl vmlseterrstatus (const int * status); extern int __cdecl vmlSetErrStatus (const int status); extern int __cdecl VMLGETERRSTATUS (void); extern int __cdecl vmlgeterrstatus (void); extern int __cdecl vmlGetErrStatus (void); extern int __cdecl VMLCLEARERRSTATUS (void); extern int __cdecl vmlclearerrstatus (void); extern int __cdecl vmlClearErrStatus (void); extern VMLErrorCallBack __cdecl VMLSETERRORCALLBACK (const VMLErrorCallBack func); extern VMLErrorCallBack __cdecl vmlseterrorcallback (const VMLErrorCallBack func); extern VMLErrorCallBack __cdecl vmlSetErrorCallBack (const VMLErrorCallBack func); extern VMLErrorCallBack __cdecl VMLGETERRORCALLBACK (void); extern VMLErrorCallBack __cdecl vmlgeterrorcallback (void); extern VMLErrorCallBack __cdecl vmlGetErrorCallBack (void); extern VMLErrorCallBack __cdecl VMLCLEARERRORCALLBACK (void); extern VMLErrorCallBack __cdecl vmlclearerrorcallback (void); extern VMLErrorCallBack __cdecl vmlClearErrorCallBack (void); extern unsigned int __cdecl VMLSETMODE (const unsigned int *newmode); extern unsigned int __cdecl vmlsetmode (const unsigned int *newmode); extern unsigned int __cdecl vmlSetMode (const unsigned int newmode); extern unsigned int __cdecl VMLGETMODE (void); extern unsigned int __cdecl vmlgetmode (void); extern unsigned int __cdecl vmlGetMode (void); extern void __cdecl MKLFREETLS (const unsigned int *fdwReason); extern void __cdecl mklfreetls (const unsigned int *fdwReason); extern void __cdecl MKLFreeTls (const unsigned int fdwReason); #line 33 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 45 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 64 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 120 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 221 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 238 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 253 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 291 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 366 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 1031 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 1075 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 30 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_functions.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_types.h" typedef void* VSLStreamStatePtr; typedef void* VSLConvTaskPtr; typedef void* VSLCorrTaskPtr; typedef void* VSLSSTaskPtr; typedef int (*InitStreamPtr)( int method, VSLStreamStatePtr stream, int n, const unsigned int params[] ); typedef int (*sBRngPtr)( VSLStreamStatePtr stream, int n, float r[], float a, float b ); typedef int (*dBRngPtr)( VSLStreamStatePtr stream, int n, double r[], double a, double b ); typedef int (*iBRngPtr)( VSLStreamStatePtr stream, int n, unsigned int r[] ); typedef int (*iUpdateFuncPtr)( VSLStreamStatePtr stream, int* n, unsigned int ibuf[], int* nmin, int* nmax, int* idx ); typedef int (*dUpdateFuncPtr)( VSLStreamStatePtr stream, int* n, double dbuf[], int* nmin, int* nmax, int* idx ); typedef int (*sUpdateFuncPtr)( VSLStreamStatePtr stream, int* n, float sbuf[], int* nmin, int* nmax, int* idx ); typedef struct _VSLBRngProperties { int StreamStateSize; int NSeeds; int IncludesZero; int WordSize; int NBits; InitStreamPtr InitStream; sBRngPtr sBRng; dBRngPtr dBRng; iBRngPtr iBRng; } VSLBRngProperties; #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_functions.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_functions.h" extern int __cdecl vdRngCauchy (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGCAUCHY (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrngcauchy (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngCauchy (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGCAUCHY (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrngcauchy (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngUniform (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGUNIFORM (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnguniform (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngUniform (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGUNIFORM (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnguniform (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngGaussian (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGGAUSSIAN (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnggaussian (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngGaussian (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGGAUSSIAN (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnggaussian (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngGaussianMV (const int , VSLStreamStatePtr , const int , double [], const int , const int , const double *, const double *); extern int __cdecl VDRNGGAUSSIANMV (const int *, VSLStreamStatePtr *, const int *, double [], const int *, const int *, const double *, const double *); extern int __cdecl vdrnggaussianmv (const int *, VSLStreamStatePtr *, const int *, double [], const int *, const int *, const double *, const double *); extern int __cdecl vsRngGaussianMV (const int , VSLStreamStatePtr , const int , float [], const int , const int , const float *, const float * ); extern int __cdecl VSRNGGAUSSIANMV (const int *, VSLStreamStatePtr *, const int *, float [], const int *, const int *, const float *, const float * ); extern int __cdecl vsrnggaussianmv (const int *, VSLStreamStatePtr *, const int *, float [], const int *, const int *, const float *, const float * ); extern int __cdecl vdRngExponential (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGEXPONENTIAL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrngexponential (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngExponential (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGEXPONENTIAL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrngexponential (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngLaplace (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGLAPLACE (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnglaplace (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngLaplace (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGLAPLACE (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnglaplace (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngWeibull (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double ); extern int __cdecl VDRNGWEIBULL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vdrngweibull (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vsRngWeibull (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float ); extern int __cdecl VSRNGWEIBULL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vsrngweibull (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vdRngRayleigh (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGRAYLEIGH (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrngrayleigh (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngRayleigh (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGRAYLEIGH (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrngrayleigh (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngLognormal (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double , const double ); extern int __cdecl VDRNGLOGNORMAL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vdrnglognormal (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vsRngLognormal (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float , const float ); extern int __cdecl VSRNGLOGNORMAL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl vsrnglognormal (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl vdRngGumbel (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGGUMBEL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnggumbel (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngGumbel (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGGUMBEL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnggumbel (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngGamma (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double ); extern int __cdecl VDRNGGAMMA (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vdrnggamma (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vsRngGamma (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float ); extern int __cdecl VSRNGGAMMA (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vsrnggamma (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vdRngBeta (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double , const double ); extern int __cdecl VDRNGBETA (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vdrngbeta (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vsRngBeta (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float , const float ); extern int __cdecl VSRNGBETA (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl vsrngbeta (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl viRngBernoulli (const int , VSLStreamStatePtr , const int , int [], const double ); extern int __cdecl VIRNGBERNOULLI (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl virngbernoulli (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl viRngUniform (const int , VSLStreamStatePtr , const int , int [], const int , const int ); extern int __cdecl VIRNGUNIFORM (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *); extern int __cdecl virnguniform (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *); extern int __cdecl viRngUniformBits (const int , VSLStreamStatePtr , const int , unsigned int []); extern int __cdecl VIRNGUNIFORMBITS (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl virnguniformbits (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl viRngUniformBits32 (const int , VSLStreamStatePtr , const int , unsigned int []); extern int __cdecl VIRNGUNIFORMBITS32 (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl virnguniformbits32 (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl viRngUniformBits64 (const int , VSLStreamStatePtr , const int , unsigned long long int []); extern int __cdecl VIRNGUNIFORMBITS64 (const int *, VSLStreamStatePtr *, const int *, unsigned long long int []); extern int __cdecl virnguniformbits64 (const int *, VSLStreamStatePtr *, const int *, unsigned long long int []); extern int __cdecl viRngGeometric (const int , VSLStreamStatePtr , const int , int [], const double ); extern int __cdecl VIRNGGEOMETRIC (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl virnggeometric (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl viRngBinomial (const int , VSLStreamStatePtr , const int , int [], const int , const double ); extern int __cdecl VIRNGBINOMIAL (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const double *); extern int __cdecl virngbinomial (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const double *); extern int __cdecl viRngHypergeometric (const int , VSLStreamStatePtr , const int , int [], const int , const int , const int ); extern int __cdecl VIRNGHYPERGEOMETRIC (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *, const int *); extern int __cdecl virnghypergeometric (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *, const int *); extern int __cdecl viRngNegbinomial (const int , VSLStreamStatePtr , const int , int [], const double , const double ); extern int __cdecl viRngNegBinomial (const int , VSLStreamStatePtr , const int , int [], const double , const double ); extern int __cdecl VIRNGNEGBINOMIAL (const int *, VSLStreamStatePtr *, const int *, int [], const double *, const double *); extern int __cdecl virngnegbinomial (const int *, VSLStreamStatePtr *, const int *, int [], const double *, const double *); extern int __cdecl viRngPoisson (const int , VSLStreamStatePtr , const int , int [], const double ); extern int __cdecl VIRNGPOISSON (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl virngpoisson (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl viRngPoissonV (const int , VSLStreamStatePtr , const int , int [], const double []); extern int __cdecl VIRNGPOISSONV (const int *, VSLStreamStatePtr *, const int *, int [], const double []); extern int __cdecl virngpoissonv (const int *, VSLStreamStatePtr *, const int *, int [], const double []); extern int __cdecl vslNewStream (VSLStreamStatePtr* , const int , const unsigned int ); extern int __cdecl vslnewstream (VSLStreamStatePtr* , const int *, const unsigned int *); extern int __cdecl VSLNEWSTREAM (VSLStreamStatePtr* , const int *, const unsigned int *); extern int __cdecl vslNewStreamEx (VSLStreamStatePtr* , const int , const int , const unsigned int[]); extern int __cdecl vslnewstreamex (VSLStreamStatePtr* , const int *, const int *, const unsigned int[]); extern int __cdecl VSLNEWSTREAMEX (VSLStreamStatePtr* , const int *, const int *, const unsigned int[]); extern int __cdecl vsliNewAbstractStream (VSLStreamStatePtr* , const int , const unsigned int[], const iUpdateFuncPtr); extern int __cdecl vslinewabstractstream (VSLStreamStatePtr* , const int *, const unsigned int[], const iUpdateFuncPtr); extern int __cdecl VSLINEWABSTRACTSTREAM (VSLStreamStatePtr* , const int *, const unsigned int[], const iUpdateFuncPtr); extern int __cdecl vsldNewAbstractStream (VSLStreamStatePtr* , const int , const double[], const double , const double , const dUpdateFuncPtr); extern int __cdecl vsldnewabstractstream (VSLStreamStatePtr* , const int *, const double[], const double *, const double *, const dUpdateFuncPtr); extern int __cdecl VSLDNEWABSTRACTSTREAM (VSLStreamStatePtr* , const int *, const double[], const double *, const double *, const dUpdateFuncPtr); extern int __cdecl vslsNewAbstractStream (VSLStreamStatePtr* , const int , const float[], const float , const float , const sUpdateFuncPtr); extern int __cdecl vslsnewabstractstream (VSLStreamStatePtr* , const int *, const float[], const float *, const float *, const sUpdateFuncPtr); extern int __cdecl VSLSNEWABSTRACTSTREAM (VSLStreamStatePtr* , const int *, const float[], const float *, const float *, const sUpdateFuncPtr); extern int __cdecl vslDeleteStream (VSLStreamStatePtr*); extern int __cdecl vsldeletestream (VSLStreamStatePtr*); extern int __cdecl VSLDELETESTREAM (VSLStreamStatePtr*); extern int __cdecl vslCopyStream (VSLStreamStatePtr*, const VSLStreamStatePtr); extern int __cdecl vslcopystream (VSLStreamStatePtr*, const VSLStreamStatePtr); extern int __cdecl VSLCOPYSTREAM (VSLStreamStatePtr*, const VSLStreamStatePtr); extern int __cdecl vslCopyStreamState (VSLStreamStatePtr , const VSLStreamStatePtr ); extern int __cdecl vslcopystreamstate (VSLStreamStatePtr *, const VSLStreamStatePtr *); extern int __cdecl VSLCOPYSTREAMSTATE (VSLStreamStatePtr *, const VSLStreamStatePtr *); extern int __cdecl vslLeapfrogStream (VSLStreamStatePtr , const int , const int ); extern int __cdecl vslleapfrogstream (VSLStreamStatePtr *, const int *, const int *); extern int __cdecl VSLLEAPFROGSTREAM (VSLStreamStatePtr *, const int *, const int *); extern int __cdecl vslSkipAheadStream (VSLStreamStatePtr , const __int64 ); extern int __cdecl vslskipaheadstream (VSLStreamStatePtr *, const __int64 *); extern int __cdecl VSLSKIPAHEADSTREAM (VSLStreamStatePtr *, const __int64 *); extern int __cdecl vslGetStreamStateBrng (const VSLStreamStatePtr ); extern int __cdecl vslgetstreamstatebrng (const VSLStreamStatePtr *); extern int __cdecl VSLGETSTREAMSTATEBRNG (const VSLStreamStatePtr *); extern int __cdecl vslGetNumRegBrngs (void); extern int __cdecl vslgetnumregbrngs (void); extern int __cdecl VSLGETNUMREGBRNGS (void); extern int __cdecl vslRegisterBrng (const VSLBRngProperties* ); extern int __cdecl vslregisterbrng (const VSLBRngProperties* ); extern int __cdecl VSLREGISTERBRNG (const VSLBRngProperties* ); extern int __cdecl vslGetBrngProperties (const int , VSLBRngProperties* ); extern int __cdecl vslgetbrngproperties (const int *, VSLBRngProperties* ); extern int __cdecl VSLGETBRNGPROPERTIES (const int *, VSLBRngProperties* ); extern int __cdecl vslSaveStreamF (const VSLStreamStatePtr , const char* ); extern int __cdecl vslsavestreamf (const VSLStreamStatePtr *, const char* , const int ); extern int __cdecl VSLSAVESTREAMF (const VSLStreamStatePtr *, const char* , const int ); extern int __cdecl vslLoadStreamF (VSLStreamStatePtr *, const char* ); extern int __cdecl vslloadstreamf (VSLStreamStatePtr *, const char* , const int ); extern int __cdecl VSLLOADSTREAMF (VSLStreamStatePtr *, const char* , const int ); extern int __cdecl vslSaveStreamM (const VSLStreamStatePtr , char* ); extern int __cdecl vslsavestreamm (const VSLStreamStatePtr *, char* ); extern int __cdecl VSLSAVESTREAMM (const VSLStreamStatePtr *, char* ); extern int __cdecl vslLoadStreamM (VSLStreamStatePtr *, const char* ); extern int __cdecl vslloadstreamm (VSLStreamStatePtr *, const char* ); extern int __cdecl VSLLOADSTREAMM (VSLStreamStatePtr *, const char* ); extern int __cdecl vslGetStreamSize (const VSLStreamStatePtr); extern int __cdecl vslgetstreamsize (const VSLStreamStatePtr); extern int __cdecl VSLGETSTREAMSIZE (const VSLStreamStatePtr); extern int __cdecl vsldConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vsldconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLDCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslsConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslsconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLSCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslzConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslzconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLZCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslcConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslcconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLCCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vsldCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vsldcorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLDCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslsCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslscorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLSCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslzCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslzcorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLZCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslcCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslccorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLCCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vsldConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vsldconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLDCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslsConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslsconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLSCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslzConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslzconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLZCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslcConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslcconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLCCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vsldCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vsldcorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLDCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslsCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslscorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLSCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslzCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslzcorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLZCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslcCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslccorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLCCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vsldConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vsldconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl VSLDCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vslsConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslsconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl VSLSCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslzConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslzconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl VSLZCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslcConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vslcconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl VSLCCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vsldCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vsldcorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl VSLDCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vslsCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslscorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl VSLSCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslzCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslzcorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl VSLZCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslcCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vslccorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl VSLCCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vsldConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const double [], const int ); extern int __cdecl vsldconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl VSLDCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl vslsConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const float [], const int ); extern int __cdecl vslsconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl VSLSCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl vslzConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const MKL_Complex16 [], const int ); extern int __cdecl vslzconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl VSLZCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl vslcConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const MKL_Complex8 [], const int ); extern int __cdecl vslcconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl VSLCCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl vsldCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const double [], const int ); extern int __cdecl vsldcorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl VSLDCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl vslsCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const float [], const int ); extern int __cdecl vslscorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl VSLSCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl vslzCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const MKL_Complex16 [], const int ); extern int __cdecl vslzcorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl VSLZCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl vslcCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const MKL_Complex8 [], const int ); extern int __cdecl vslccorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl VSLCCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl vslConvDeleteTask (VSLConvTaskPtr* ); extern int __cdecl vslconvdeletetask (VSLConvTaskPtr* ); extern int __cdecl VSLCONVDeleteTask (VSLConvTaskPtr* ); extern int __cdecl vslCorrDeleteTask (VSLCorrTaskPtr* ); extern int __cdecl vslcorrdeletetask (VSLCorrTaskPtr* ); extern int __cdecl VSLCORRDeleteTask (VSLCorrTaskPtr* ); extern int __cdecl vslConvCopyTask (VSLConvTaskPtr* , const VSLConvTaskPtr ); extern int __cdecl vslconvcopytask (VSLConvTaskPtr* , const VSLConvTaskPtr* ); extern int __cdecl VSLCONVCopyTask (VSLConvTaskPtr* , const VSLConvTaskPtr* ); extern int __cdecl vslCorrCopyTask (VSLCorrTaskPtr* , const VSLCorrTaskPtr ); extern int __cdecl vslcorrcopytask (VSLCorrTaskPtr* , const VSLCorrTaskPtr* ); extern int __cdecl VSLCORRCopyTask (VSLCorrTaskPtr* , const VSLCorrTaskPtr* ); extern int __cdecl vslConvSetMode (VSLConvTaskPtr , const int ); extern int __cdecl vslconvsetmode (VSLConvTaskPtr* , const int* ); extern int __cdecl VSLCONVSETMODE (VSLConvTaskPtr* , const int* ); extern int __cdecl vslCorrSetMode (VSLCorrTaskPtr , const int ); extern int __cdecl vslcorrsetmode (VSLCorrTaskPtr* , const int* ); extern int __cdecl VSLCORRSETMODE (VSLCorrTaskPtr* , const int* ); extern int __cdecl vslConvSetInternalPrecision (VSLConvTaskPtr , const int ); extern int __cdecl vslconvsetinternalprecision (VSLConvTaskPtr* , const int* ); extern int __cdecl VSLCONVSETINTERNALPRECISION (VSLConvTaskPtr* , const int* ); extern int __cdecl vslCorrSetInternalPrecision (VSLCorrTaskPtr , const int ); extern int __cdecl vslcorrsetinternalprecision (VSLCorrTaskPtr* , const int* ); extern int __cdecl VSLCORRSETINTERNALPRECISION (VSLCorrTaskPtr* , const int* ); extern int __cdecl vslConvSetStart (VSLConvTaskPtr , const int []); extern int __cdecl vslconvsetstart (VSLConvTaskPtr* , const int []); extern int __cdecl VSLCONVSETSTART (VSLConvTaskPtr* , const int []); extern int __cdecl vslCorrSetStart (VSLCorrTaskPtr , const int []); extern int __cdecl vslcorrsetstart (VSLCorrTaskPtr* , const int []); extern int __cdecl VSLCORRSETSTART (VSLCorrTaskPtr* , const int []); extern int __cdecl vslConvSetDecimation (VSLConvTaskPtr , const int []); extern int __cdecl vslconvsetdecimation (VSLConvTaskPtr* , const int []); extern int __cdecl VSLCONVSETDECIMATION (VSLConvTaskPtr* , const int []); extern int __cdecl vslCorrSetDecimation (VSLCorrTaskPtr , const int []); extern int __cdecl vslcorrsetdecimation (VSLCorrTaskPtr* , const int []); extern int __cdecl VSLCORRSETDECIMATION (VSLCorrTaskPtr* , const int []); extern int __cdecl vsldConvExec (VSLConvTaskPtr , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vsldconvexec (VSLConvTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl VSLDCONVEXEC (VSLConvTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vslsConvExec (VSLConvTaskPtr , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslsconvexec (VSLConvTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl VSLSCONVEXEC (VSLConvTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslzConvExec (VSLConvTaskPtr , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzconvexec (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCONVEXEC (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcConvExec (VSLConvTaskPtr , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslcconvexec (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCONVEXEC (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldCorrExec (VSLCorrTaskPtr , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vsldcorrexec (VSLCorrTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl VSLDCORREXEC (VSLCorrTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vslsCorrExec (VSLCorrTaskPtr , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslscorrexec (VSLCorrTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl VSLSCORREXEC (VSLCorrTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslzCorrExec (VSLCorrTaskPtr , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzcorrexec (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCORREXEC (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcCorrExec (VSLCorrTaskPtr , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslccorrexec (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCORREXEC (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldConvExec1D (VSLConvTaskPtr , const double [], const int , const double [], const int , double [], const int ); extern int __cdecl vsldconvexec1d (VSLConvTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCONVEXEC1D (VSLConvTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl vslsConvExec1D (VSLConvTaskPtr , const float [], const int , const float [], const int , float [], const int ); extern int __cdecl vslsconvexec1d (VSLConvTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCONVEXEC1D (VSLConvTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl vslzConvExec1D (VSLConvTaskPtr , const MKL_Complex16 [], const int , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzconvexec1d (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCONVEXEC1D (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcConvExec1D (VSLConvTaskPtr , const MKL_Complex8 [], const int , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslcconvexec1d (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCONVEXEC1D (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldCorrExec1D (VSLCorrTaskPtr , const double [], const int , const double [], const int , double [], const int ); extern int __cdecl vsldcorrexec1d (VSLCorrTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCORREXEC1D (VSLCorrTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl vslsCorrExec1D (VSLCorrTaskPtr , const float [], const int , const float [], const int , float [], const int ); extern int __cdecl vslscorrexec1d (VSLCorrTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCORREXEC1D (VSLCorrTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl vslzCorrExec1D (VSLCorrTaskPtr , const MKL_Complex16 [], const int , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzcorrexec1d (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCORREXEC1D (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcCorrExec1D (VSLCorrTaskPtr , const MKL_Complex8 [], const int , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslccorrexec1d (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCORREXEC1D (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldConvExecX (VSLConvTaskPtr , const double [], const int [], double [], const int []); extern int __cdecl vsldconvexecx (VSLConvTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl VSLDCONVEXECX (VSLConvTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl vslsConvExecX (VSLConvTaskPtr , const float [], const int [], float [], const int []); extern int __cdecl vslsconvexecx (VSLConvTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl VSLSCONVEXECX (VSLConvTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl vslzConvExecX (VSLConvTaskPtr , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzconvexecx (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCONVEXECX (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcConvExecX (VSLConvTaskPtr , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslcconvexecx (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCONVEXECX (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldCorrExecX (VSLCorrTaskPtr , const double [], const int [], double [], const int []); extern int __cdecl vsldcorrexecx (VSLCorrTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl VSLDCORREXECX (VSLCorrTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl vslsCorrExecX (VSLCorrTaskPtr , const float [], const int [], float [], const int []); extern int __cdecl vslscorrexecx (VSLCorrTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl VSLSCORREXECX (VSLCorrTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl vslzCorrExecX (VSLCorrTaskPtr , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzcorrexecx (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCORREXECX (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcCorrExecX (VSLCorrTaskPtr , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslccorrexecx (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCORREXECX (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldConvExecX1D (VSLConvTaskPtr , const double [], const int , double [], const int ); extern int __cdecl vsldconvexecx1d (VSLConvTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCONVEXECX1D (VSLConvTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl vslsConvExecX1D (VSLConvTaskPtr , const float [], const int , float [], const int ); extern int __cdecl vslsconvexecx1d (VSLConvTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCONVEXECX1D (VSLConvTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl vslzConvExecX1D (VSLConvTaskPtr , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzconvexecx1d (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCONVEXECX1D (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcConvExecX1D (VSLConvTaskPtr , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslcconvexecx1d (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCONVEXECX1D (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldCorrExecX1D (VSLCorrTaskPtr , const double [], const int , double [], const int ); extern int __cdecl vsldcorrexecx1d (VSLCorrTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCORREXECX1D (VSLCorrTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl vslsCorrExecX1D (VSLCorrTaskPtr , const float [], const int , float [], const int ); extern int __cdecl vslscorrexecx1d (VSLCorrTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCORREXECX1D (VSLCorrTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl vslzCorrExecX1D (VSLCorrTaskPtr , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzcorrexecx1d (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCORREXECX1D (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcCorrExecX1D (VSLCorrTaskPtr , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslccorrexecx1d (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCORREXECX1D (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldSSNewTask (VSLSSTaskPtr* , const int* , const int* , const int* , const double [], const double [], const int []); extern int __cdecl vsldssnewtask (VSLSSTaskPtr* , const int* , const int* , const int* , const double [], const double [], const int []); extern int __cdecl VSLDSSNEWTASK (VSLSSTaskPtr* , const int* , const int* , const int* , const double [], const double [], const int []); extern int __cdecl vslsSSNewTask (VSLSSTaskPtr* , const int* , const int* , const int* , const float [], const float [], const int []); extern int __cdecl vslsssnewtask (VSLSSTaskPtr* , const int* , const int* , const int* , const float [], const float [], const int []); extern int __cdecl VSLSSSNEWTASK (VSLSSTaskPtr* , const int* , const int* , const int* , const float [], const float [], const int []); extern int __cdecl vsldSSEditTask (VSLSSTaskPtr , const int , const double* ); extern int __cdecl vsldssedittask (VSLSSTaskPtr* , const int* , const double* ); extern int __cdecl VSLDSSEDITTASK (VSLSSTaskPtr* , const int* , const double* ); extern int __cdecl vslsSSEditTask (VSLSSTaskPtr , const int , const float* ); extern int __cdecl vslsssedittask (VSLSSTaskPtr* , const int* , const float* ); extern int __cdecl VSLSSSEDITTASK (VSLSSTaskPtr* , const int* , const float* ); extern int __cdecl vsliSSEditTask (VSLSSTaskPtr , const int , const int* ); extern int __cdecl vslissedittask (VSLSSTaskPtr* , const int* , const int* ); extern int __cdecl VSLISSEDITTASK (VSLSSTaskPtr* , const int* , const int* ); extern int __cdecl vsldSSEditMoments (VSLSSTaskPtr , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vsldsseditmoments (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl VSLDSSEDITMOMENTS (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vslsSSEditMoments (VSLSSTaskPtr , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vslssseditmoments (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl VSLSSSEDITMOMENTS (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vsldSSEditSums (VSLSSTaskPtr , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vsldsseditsums (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl VSLDSSEDITSUMS (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vslsSSEditSums (VSLSSTaskPtr , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vslssseditsums (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl VSLSSSEDITSUMS (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vsldSSEditCovCor (VSLSSTaskPtr , double* , double* , const int* , double* , const int* ); extern int __cdecl vsldsseditcovcor (VSLSSTaskPtr* , double* , double* , const int* , double* , const int* ); extern int __cdecl VSLDSSEDITCOVCOR (VSLSSTaskPtr* , double* , double* , const int* , double* , const int* ); extern int __cdecl vslsSSEditCovCor (VSLSSTaskPtr , float* , float* , const int* , float* , const int* ); extern int __cdecl vslssseditcovcor (VSLSSTaskPtr* , float* , float* , const int* , float* , const int* ); extern int __cdecl VSLSSSEDITCOVCOR (VSLSSTaskPtr* , float* , float* , const int* , float* , const int* ); extern int __cdecl vsldSSEditCP (VSLSSTaskPtr , double* , double* , double* , const int* ); extern int __cdecl vsldsseditcp (VSLSSTaskPtr* , double* , double* , double* , const int* ); extern int __cdecl VSLDSSEDITCP (VSLSSTaskPtr* , double* , double* , double* , const int* ); extern int __cdecl vslsSSEditCP (VSLSSTaskPtr , float* , float* , float* , const int* ); extern int __cdecl vslssseditcp (VSLSSTaskPtr* , float* , float* , float* , const int* ); extern int __cdecl VSLSSSEDITCP (VSLSSTaskPtr* , float* , float* , float* , const int* ); extern int __cdecl vsldSSEditPartialCovCor (VSLSSTaskPtr , const int [], const double* , const int* , const double* , const int* , double* , const int* , double* , const int* ); extern int __cdecl vsldsseditpartialcovcor (VSLSSTaskPtr* , const int [], const double* , const int* , const double* , const int* , double* , const int* , double* , const int* ); extern int __cdecl VSLDSSEDITPARTIALCOVCOR (VSLSSTaskPtr* , const int [], const double* , const int* , const double* , const int* , double* , const int* , double* , const int* ); extern int __cdecl vslsSSEditPartialCovCor (VSLSSTaskPtr , const int [], const float* , const int* , const float* , const int* , float* , const int* , float* , const int* ); extern int __cdecl vslssseditpartialcovcor (VSLSSTaskPtr* , const int [], const float* , const int* , const float* , const int* , float* , const int* , float* , const int* ); extern int __cdecl VSLSSSEDITPARTIALCOVCOR (VSLSSTaskPtr* , const int [], const float* , const int* , const float* , const int* , float* , const int* , float* , const int* ); extern int __cdecl vsldSSEditQuantiles (VSLSSTaskPtr , const int* , const double* , double* , double* , const int* ); extern int __cdecl vsldsseditquantiles (VSLSSTaskPtr* , const int* , const double* , double* , double* , const int* ); extern int __cdecl VSLDSSEDITQUANTILES (VSLSSTaskPtr* , const int* , const double* , double* , double* , const int* ); extern int __cdecl vslsSSEditQuantiles (VSLSSTaskPtr , const int* , const float* , float* , float* , const int* ); extern int __cdecl vslssseditquantiles (VSLSSTaskPtr* , const int* , const float* , float* , float* , const int* ); extern int __cdecl VSLSSSEDITQUANTILES (VSLSSTaskPtr* , const int* , const float* , float* , float* , const int* ); extern int __cdecl vsldSSEditStreamQuantiles (VSLSSTaskPtr , const int* , const double* , double* , const int* , const double* ); extern int __cdecl vsldsseditstreamquantiles (VSLSSTaskPtr* , const int* , const double* , double* , const int* , const double* ); extern int __cdecl VSLDSSEDITSTREAMQUANTILES (VSLSSTaskPtr* , const int* , const double* , double* , const int* , const double* ); extern int __cdecl vslsSSEditStreamQuantiles (VSLSSTaskPtr , const int* , const float* , float* , const int* , const float* ); extern int __cdecl vslssseditstreamquantiles (VSLSSTaskPtr* , const int* , const float* , float* , const int* , const float* ); extern int __cdecl VSLSSSEDITSTREAMQUANTILES (VSLSSTaskPtr* , const int* , const float* , float* , const int* , const float* ); extern int __cdecl vsldSSEditPooledCovariance (VSLSSTaskPtr , const int* , double* , double* , const int* , double* , double* ); extern int __cdecl vsldsseditpooledcovariance (VSLSSTaskPtr* , const int* , double* , double* , const int* , double* , double* ); extern int __cdecl VSLDSSEDITPOOLEDCOVARIANCE (VSLSSTaskPtr* , const int* , double* , double* , const int* , double* , double* ); extern int __cdecl vslsSSEditPooledCovariance (VSLSSTaskPtr , const int* , float* , float* , const int* , float* , float* ); extern int __cdecl vslssseditpooledcovariance (VSLSSTaskPtr* , const int* , float* , float* , const int* , float* , float* ); extern int __cdecl VSLSSSEDITPOOLEDCOVARIANCE (VSLSSTaskPtr* , const int* , float* , float* , const int* , float* , float* ); extern int __cdecl vsldSSEditRobustCovariance (VSLSSTaskPtr , const int* , const int* , const double* , double* , double* ); extern int __cdecl vsldsseditrobustcovariance (VSLSSTaskPtr* , const int* , const int* , const double* , double* , double* ); extern int __cdecl VSLDSSEDITROBUSTCOVARIANCE (VSLSSTaskPtr* , const int* , const int* , const double* , double* , double* ); extern int __cdecl vslsSSEditRobustCovariance (VSLSSTaskPtr , const int* , const int* , const float* , float* , float* ); extern int __cdecl vslssseditrobustcovariance (VSLSSTaskPtr* , const int* , const int* , const float* , float* , float* ); extern int __cdecl VSLSSSEDITROBUSTCOVARIANCE (VSLSSTaskPtr* , const int* , const int* , const float* , float* , float* ); extern int __cdecl vsldSSEditOutliersDetection (VSLSSTaskPtr , const int* , const double* , double* ); extern int __cdecl vsldsseditoutliersdetection (VSLSSTaskPtr* , const int* , const double* , double* ); extern int __cdecl VSLDSSEDITOUTLIERSDETECTION (VSLSSTaskPtr* , const int* , const double* , double* ); extern int __cdecl vslsSSEditOutliersDetection (VSLSSTaskPtr , const int* , const float* , float* ); extern int __cdecl vslssseditoutliersdetection (VSLSSTaskPtr* , const int* , const float* , float* ); extern int __cdecl VSLSSSEDITOUTLIERSDETECTION (VSLSSTaskPtr* , const int* , const float* , float* ); extern int __cdecl vsldSSEditMissingValues (VSLSSTaskPtr , const int* , const double* , const int* , const double* , const int* , const double* , const int* , double* , const int* , double* ); extern int __cdecl vsldsseditmissingvalues (VSLSSTaskPtr* , const int* , const double* , const int* , const double* , const int* , const double* , const int* , double* , const int* , double* ); extern int __cdecl VSLDSSEDITMISSINGVALUES (VSLSSTaskPtr* , const int* , const double* , const int* , const double* , const int* , const double* , const int* , double* , const int* , double* ); extern int __cdecl vslsSSEditMissingValues (VSLSSTaskPtr , const int* , const float* , const int* , const float* , const int* , const float* , const int* , float* , const int* , float* ); extern int __cdecl vslssseditmissingvalues (VSLSSTaskPtr* , const int* , const float* , const int* , const float* , const int* , const float* , const int* , float* , const int* , float* ); extern int __cdecl VSLSSSEDITMISSINGVALUES (VSLSSTaskPtr* , const int* , const float* , const int* , const float* , const int* , const float* , const int* , float* , const int* , float* ); extern int __cdecl vsldSSEditCorParameterization (VSLSSTaskPtr , const double* , const int* , double* , const int* ); extern int __cdecl vsldsseditcorparameterization (VSLSSTaskPtr* , const double* , const int* , double* , const int* ); extern int __cdecl VSLDSSEDITCORPARAMETERIZATION (VSLSSTaskPtr* , const double* , const int* , double* , const int* ); extern int __cdecl vslsSSEditCorParameterization (VSLSSTaskPtr , const float* , const int* , float* , const int* ); extern int __cdecl vslssseditcorparameterization (VSLSSTaskPtr* , const float* , const int* , float* , const int* ); extern int __cdecl VSLSSSEDITCORPARAMETERIZATION (VSLSSTaskPtr* , const float* , const int* , float* , const int* ); extern int __cdecl vsldSSCompute (VSLSSTaskPtr , const unsigned long long int , const int ); extern int __cdecl vsldsscompute (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl VSLDSSCOMPUTE (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl vslsSSCompute (VSLSSTaskPtr , const unsigned long long int , const int ); extern int __cdecl vslssscompute (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl VSLSSSCOMPUTE (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl vslSSDeleteTask (VSLSSTaskPtr* ); extern int __cdecl vslssdeletetask (VSLSSTaskPtr* ); extern int __cdecl VSLSSDELETETASK (VSLSSTaskPtr* ); #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl.h" #line 51 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 73 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 91 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 130 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 157 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 172 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 30 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_functions.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_types.h" typedef void* DFTaskPtr; typedef struct _dfSearchCallBackLibraryParams{ int limit_type_flag; } dfSearchCallBackLibraryParams; typedef struct _dfInterpCallBackLibraryParams{ int reserved1; } dfInterpCallBackLibraryParams; typedef struct _dfIntegrCallBackLibraryParams{ int reserved1; } dfIntegrCallBackLibraryParams; typedef int (*dfsInterpCallBack) ( long long int* n, long long int cell[], float site[], float r[], void* user_param, dfInterpCallBackLibraryParams* library_params ); typedef int (*dfdInterpCallBack) ( long long int* n, long long int cell[], double site[], double r[], void* user_param, dfInterpCallBackLibraryParams* library_params ); typedef int (*dfsIntegrCallBack) ( long long int* n, long long int lcell[], float llim[], long long int rcell[], float rlim[], float r[], void* user_params, dfIntegrCallBackLibraryParams* library_params ); typedef int (*dfdIntegrCallBack) ( long long int* n, long long int lcell[], double llim[], long long int rcell[], double rlim[], double r[], void* user_params, dfIntegrCallBackLibraryParams* library_params ); typedef int (*dfsSearchCellsCallBack) ( long long int* n, float site[], long long int cell[], int flag[], void* user_params, dfSearchCallBackLibraryParams* library_params ); typedef int (*dfdSearchCellsCallBack) ( long long int* n, double site[], long long int cell[], int flag[], void* user_params, dfSearchCallBackLibraryParams* library_params ); #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_functions.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_functions.h" extern int __cdecl dfsNewTask1D (DFTaskPtr *, const int , const float [], const int , const int , const float [], const int ); extern int __cdecl dfsnewtask1d (DFTaskPtr *, const int *, const float [], const int *, const int *, const float [], const int *); extern int __cdecl DFSNEWTASK1D (DFTaskPtr *, const int *, const float [], const int *, const int *, const float [], const int *); extern int __cdecl dfdNewTask1D (DFTaskPtr *, const int , const double [], const int , const int , const double [], const int ); extern int __cdecl dfdnewtask1d (DFTaskPtr *, const int *, const double [], const int *, const int *, const double [], const int *); extern int __cdecl DFDNEWTASK1D (DFTaskPtr *, const int *, const double [], const int *, const int *, const double [], const int *); extern int __cdecl dfsEditPtr (DFTaskPtr , const int , const float *); extern int __cdecl dfseditptr (DFTaskPtr *, const int *, const float *); extern int __cdecl DFSEDITPTR (DFTaskPtr *, const int *, const float *); extern int __cdecl dfdEditPtr (DFTaskPtr , const int , const double *); extern int __cdecl dfdeditptr (DFTaskPtr *, const int *, const double *); extern int __cdecl DFDEDITPTR (DFTaskPtr *, const int *, const double *); extern int __cdecl dfiEditVal (DFTaskPtr , const int , const int ); extern int __cdecl dfieditval (DFTaskPtr *, const int *, const int *); extern int __cdecl DFIEDITVAL (DFTaskPtr *, const int *, const int *); extern int __cdecl dfsEditIdxPtr (DFTaskPtr , const int , const int , const float []); extern int __cdecl dfseditidxptr (DFTaskPtr *, const int *, const int *, const float []); extern int __cdecl DFSEDITIDXPTR (DFTaskPtr *, const int *, const int *, const float []); extern int __cdecl dfdEditIdxPtr (DFTaskPtr , const int , const int , const double []); extern int __cdecl dfdeditidxptr (DFTaskPtr *, const int *, const int *, const double []); extern int __cdecl DFDEDITIDXPTR (DFTaskPtr *, const int *, const int *, const double []); extern int __cdecl dfsEditPPSpline1D (DFTaskPtr , const int , const int , const int , const float [], const int , const float [], const float [], const int ); extern int __cdecl dfseditppspline1d (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const float [], const float [], const int *); extern int __cdecl DFSEDITPPSPLINE1D (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const float [], const float [], const int *); extern int __cdecl dfdEditPPSpline1D (DFTaskPtr , const int , const int , const int , const double [], const int , const double [], const double [], const int ); extern int __cdecl dfdeditppspline1d (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const double [], const double [], const int *); extern int __cdecl DFDEDITPPSPLINE1D (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const double [], const double [], const int *); extern int __cdecl dfsQueryPtr (DFTaskPtr , const int , float **); extern int __cdecl dfsqueryptr (DFTaskPtr *, const int *, float **); extern int __cdecl DFSQUERYPTR (DFTaskPtr *, const int *, float **); extern int __cdecl dfdQueryPtr (DFTaskPtr , const int , double **); extern int __cdecl dfdqueryptr (DFTaskPtr *, const int *, double **); extern int __cdecl DFDQUERYPTR (DFTaskPtr *, const int *, double **); extern int __cdecl dfiQueryVal (DFTaskPtr , const int , int *); extern int __cdecl dfiqueryval (DFTaskPtr *, const int *, int *); extern int __cdecl DFIQUERYVAL (DFTaskPtr *, const int *, int *); extern int __cdecl dfsQueryIdxPtr (DFTaskPtr , const int , const int , float **); extern int __cdecl dfsqueryidxptr (DFTaskPtr *, const int *, const int *, float **); extern int __cdecl DFSQUERYIDXPTR (DFTaskPtr *, const int *, const int *, float **); extern int __cdecl dfdQueryIdxPtr (DFTaskPtr , const int , const int , double **); extern int __cdecl dfdqueryidxptr (DFTaskPtr *, const int *, const int *, double **); extern int __cdecl DFDQUERYIDXPTR (DFTaskPtr *, const int *, const int *, double **); extern int __cdecl dfsConstruct1D (DFTaskPtr , const int , const int ); extern int __cdecl dfsconstruct1d (DFTaskPtr *, const int *, const int *); extern int __cdecl DFSCONSTRUCT1D (DFTaskPtr *, const int *, const int *); extern int __cdecl dfdConstruct1D (DFTaskPtr , const int , const int ); extern int __cdecl dfdconstruct1d (DFTaskPtr *, const int *, const int *); extern int __cdecl DFDCONSTRUCT1D (DFTaskPtr *, const int *, const int *); extern int __cdecl dfsInterpolateEx1D (DFTaskPtr , const int , const int , const int , const float [], const int , const int , const int [], const float [], float [], const int , int [], const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfsinterpolateex1d (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [], const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl DFSINTERPOLATEEX1D (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [], const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfdInterpolateEx1D (DFTaskPtr , const int , const int , const int , const double [], const int , const int , const int [], const double [], double [], const int , int [], const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfdinterpolateex1d (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [], const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl DFDINTERPOLATEEX1D (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [], const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfsInterpolate1D (DFTaskPtr , const int , const int , const int , const float [], const int , const int , const int [], const float [], float [], const int , int [] ); extern int __cdecl dfsinterpolate1d (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [] ); extern int __cdecl DFSINTERPOLATE1D (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [] ); extern int __cdecl dfdInterpolate1D (DFTaskPtr , const int , const int , const int , const double [], const int , const int , const int [], const double [], double [], const int , int [] ); extern int __cdecl dfdinterpolate1d (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [] ); extern int __cdecl DFDINTERPOLATE1D (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [] ); extern int __cdecl dfsSearchCellsEx1D (DFTaskPtr , const int , const int , const float [], const int , const float [], int [], const dfsSearchCellsCallBack , const void * ); extern int __cdecl dfssearchcellsex1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [], const dfsSearchCellsCallBack , const void * ); extern int __cdecl DFSSEARCHCELLSEX1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [], const dfsSearchCellsCallBack , const void * ); extern int __cdecl dfdSearchCellsEx1D (DFTaskPtr , const int , const int , const double [], const int , const double [], int [], const dfdSearchCellsCallBack , const void * ); extern int __cdecl dfdsearchcellsex1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [], const dfdSearchCellsCallBack , const void * ); extern int __cdecl DFDSEARCHCELLSEX1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [], const dfdSearchCellsCallBack , const void * ); extern int __cdecl dfsSearchCells1D (DFTaskPtr , const int , const int , const float [], const int , const float [], int [] ); extern int __cdecl dfssearchcells1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [] ); extern int __cdecl DFSSEARCHCELLS1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [] ); extern int __cdecl dfdSearchCells1D (DFTaskPtr , const int , const int , const double [], const int , const double [], int [] ); extern int __cdecl dfdsearchcells1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [] ); extern int __cdecl DFDSEARCHCELLS1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [] ); extern int __cdecl dfsIntegrate1D (DFTaskPtr , const int , const int , const float [], const int , const float [], const int , const float [], const float [], float [], const int ); extern int __cdecl dfsintegrate1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *); extern int __cdecl DFSINTEGRATE1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *); extern int __cdecl dfdIntegrate1D (DFTaskPtr , const int , const int , const double [], const int , const double [], const int , const double [], const double [], double [], const int ); extern int __cdecl dfdintegrate1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *); extern int __cdecl DFDINTEGRATE1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *); extern int __cdecl dfsIntegrateEx1D (DFTaskPtr , const int , const int , const float [], const int , const float [], const int , const float [], const float [], float [], const int , const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfsintegrateex1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl DFSINTEGRATEEX1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfdIntegrateEx1D (DFTaskPtr , const int , const int , const double [], const int , const double [], const int , const double [], const double [], double [], const int , const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfdintegrateex1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl DFDINTEGRATEEX1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfDeleteTask (DFTaskPtr *); extern int __cdecl dfdeletetask (DFTaskPtr *); extern int __cdecl DFDELETETASK (DFTaskPtr *); #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df.h" #line 52 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" #line 45 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" #line 58 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" enum DFTI_CONFIG_PARAM { DFTI_FORWARD_DOMAIN = 0, DFTI_DIMENSION = 1, DFTI_LENGTHS = 2, DFTI_PRECISION = 3, DFTI_FORWARD_SCALE = 4, DFTI_BACKWARD_SCALE = 5, DFTI_NUMBER_OF_TRANSFORMS = 7, DFTI_COMPLEX_STORAGE = 8, DFTI_REAL_STORAGE = 9, DFTI_CONJUGATE_EVEN_STORAGE = 10, DFTI_PLACEMENT = 11, DFTI_INPUT_STRIDES = 12, DFTI_OUTPUT_STRIDES = 13, DFTI_INPUT_DISTANCE = 14, DFTI_OUTPUT_DISTANCE = 15, DFTI_WORKSPACE = 17, DFTI_ORDERING = 18, DFTI_TRANSPOSE = 19, DFTI_DESCRIPTOR_NAME = 20, DFTI_PACKED_FORMAT = 21, DFTI_COMMIT_STATUS = 22, DFTI_VERSION = 23, DFTI_NUMBER_OF_USER_THREADS = 26, DFTI_THREAD_LIMIT = 27, DFTI_DESTROY_INPUT = 28 }; enum DFTI_CONFIG_VALUE { DFTI_COMMITTED = 30, DFTI_UNCOMMITTED = 31, DFTI_COMPLEX = 32, DFTI_REAL = 33, DFTI_SINGLE = 35, DFTI_DOUBLE = 36, DFTI_COMPLEX_COMPLEX = 39, DFTI_COMPLEX_REAL = 40, DFTI_REAL_COMPLEX = 41, DFTI_REAL_REAL = 42, DFTI_INPLACE = 43, DFTI_NOT_INPLACE = 44, DFTI_ORDERED = 48, DFTI_BACKWARD_SCRAMBLED = 49, DFTI_ALLOW = 51, DFTI_AVOID = 52, DFTI_NONE = 53, DFTI_CCS_FORMAT = 54, DFTI_PACK_FORMAT = 55, DFTI_PERM_FORMAT = 56, DFTI_CCE_FORMAT = 57 }; typedef struct DFTI_DESCRIPTOR *DFTI_DESCRIPTOR_HANDLE; typedef struct DFTI_DESCRIPTOR DFTI_DESCRIPTOR; long int DftiCreateDescriptor(DFTI_DESCRIPTOR_HANDLE*, enum DFTI_CONFIG_VALUE, enum DFTI_CONFIG_VALUE, long int, ...); long int DftiCopyDescriptor(DFTI_DESCRIPTOR_HANDLE, DFTI_DESCRIPTOR_HANDLE*); long int DftiCommitDescriptor(DFTI_DESCRIPTOR_HANDLE); long int DftiComputeForward(DFTI_DESCRIPTOR_HANDLE, void*, ...); long int DftiComputeBackward(DFTI_DESCRIPTOR_HANDLE, void*, ...); long int DftiSetValue(DFTI_DESCRIPTOR_HANDLE, enum DFTI_CONFIG_PARAM, ...); long int DftiGetValue(DFTI_DESCRIPTOR_HANDLE, enum DFTI_CONFIG_PARAM, ...); long int DftiFreeDescriptor(DFTI_DESCRIPTOR_HANDLE*); char* DftiErrorMessage(long int); long int DftiErrorClass(long int, long int); long int DftiCreateDescriptor_s_1d(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, ... ); long int DftiCreateDescriptor_s_md(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, long int many, ... ); long int DftiCreateDescriptor_d_1d(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, ... ); long int DftiCreateDescriptor_d_md(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, long int many, ... ); #line 274 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" #line 54 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_trig_transforms.h" #line 38 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_trig_transforms.h" void d_init_trig_transform(int *, int *, int *, double *, int *); void d_commit_trig_transform(double *, DFTI_DESCRIPTOR_HANDLE *, int *, double *, int *); void d_forward_trig_transform(double *, DFTI_DESCRIPTOR_HANDLE *, int *, double *, int *); void d_backward_trig_transform(double *, DFTI_DESCRIPTOR_HANDLE *, int *, double *, int *); void s_init_trig_transform(int *, int *, int *, float *, int *); void s_commit_trig_transform(float *, DFTI_DESCRIPTOR_HANDLE *, int *, float *, int *); void s_forward_trig_transform(float *, DFTI_DESCRIPTOR_HANDLE *, int *, float *, int *); void s_backward_trig_transform(float *, DFTI_DESCRIPTOR_HANDLE *, int *, float *, int *); void free_trig_transform(DFTI_DESCRIPTOR_HANDLE *, int *, int *); #line 55 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_poisson.h" void d_init_helmholtz_2d(const double*, const double*, const double*, const double*, const int*, const int*, const char*, const double*, int*, double*, int*); void d_commit_helmholtz_2d(double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE *, int*, double*,int*); void d_helmholtz_2d(double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE *, int*, const double*,int*); void free_helmholtz_2d(DFTI_DESCRIPTOR_HANDLE*, int*, int*); void d_init_helmholtz_3d(const double*, const double*, const double*, const double*, const double*, const double*, const int*, const int*, const int*, const char*, const double*, int*, double*, int*); void d_commit_helmholtz_3d(double*, const double*, const double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, double*, int*); void d_helmholtz_3d(double*, const double*, const double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, const double*,int*); void free_helmholtz_3d(DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, int*); void s_init_helmholtz_2d(const float*, const float*, const float*, const float*, const int*, const int*, const char*, const float*, int*, float*, int*); void s_commit_helmholtz_2d(float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE *, int*, float*, int*); void s_helmholtz_2d(float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE *, int*, const float*, int*); void s_init_helmholtz_3d(const float*, const float*, const float*, const float*, const float*, const float*, const int*, const int*, const int*, const char*, const float*,int*,float*,int*); void s_commit_helmholtz_3d(float*, const float*, const float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, float*, int*); void s_helmholtz_3d(float*, const float*, const float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, const float*,int*); void d_init_sph_p(const double*, const double*, const double*, const double*, const int*, const int*, const double*, int*, double*, int*); void d_commit_sph_p(double*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void d_sph_p(double*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void free_sph_p(DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,int*); void d_init_sph_np(const double*, const double*, const double*, const double*, const int*, const int*, const double*, int*, double*, int*); void d_commit_sph_np(double*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void d_sph_np(double*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void free_sph_np(DFTI_DESCRIPTOR_HANDLE*,int*,int*); void s_init_sph_p(const float*, const float*, const float*, const float*, const int*, const int*, const float*, int*, float*,int*); void s_commit_sph_p(float*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); void s_sph_p(float*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); void s_init_sph_np(const float*, const float*, const float*, const float*, const int*, const int*, const float*, int*, float*,int*); void s_commit_sph_np(float*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); void s_sph_np(float*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); #line 56 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_solvers_ee.h" #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_solvers_ee.h" extern void __cdecl feastinit (int* fpm); extern void __cdecl FEASTINIT (int* fpm); extern void __cdecl dfeast_scsrev (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SCSREV (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl sfeast_sygv (const char* uplo , const int* n , const float* a , const int* lda , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SYGV (const char* uplo , const int* n , const float* a , const int* lda , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl sfeast_scsrev (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SCSREV (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl zfeast_hbgv (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , const int* klb , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HBGV (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , const int* klb , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl zfeast_hcsrev (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HCSREV (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl cfeast_hbev (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HBEV (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl zfeast_heev (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HEEV (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl zfeast_hcsrgv (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , const MKL_Complex16* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HCSRGV (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , const MKL_Complex16* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl sfeast_scsrgv (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , const float* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SCSRGV (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , const float* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl dfeast_srci (int* ijob , const int* n , MKL_Complex16* ze , double* work , MKL_Complex16* workc , double* aq , double* sq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , double* q , int* m , double* res , int* info); extern void __cdecl DFEAST_SRCI (int* ijob , const int* n , MKL_Complex16* ze , double* work , MKL_Complex16* workc , double* aq , double* sq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , double* q , int* m , double* res , int* info); extern void __cdecl sfeast_sbev (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SBEV (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl dfeast_sygv (const char* uplo , const int* n , const double* a , const int* lda , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SYGV (const char* uplo , const int* n , const double* a , const int* lda , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl cfeast_hegv (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HEGV (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl zfeast_hrci (int* ijob , const int* n , MKL_Complex16* ze , MKL_Complex16* work , MKL_Complex16* workc , MKL_Complex16* zaq , MKL_Complex16* zsq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , MKL_Complex16* q , int* m , double* res , int* info); extern void __cdecl ZFEAST_HRCI (int* ijob , const int* n , MKL_Complex16* ze , MKL_Complex16* work , MKL_Complex16* workc , MKL_Complex16* zaq , MKL_Complex16* zsq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , MKL_Complex16* q , int* m , double* res , int* info); extern void __cdecl cfeast_hrci (int* ijob , const int* n , MKL_Complex8* ze , MKL_Complex8* work , MKL_Complex8* workc , MKL_Complex8* zaq , MKL_Complex8* zsq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , MKL_Complex8* q , int* m , float* res , int* info); extern void __cdecl CFEAST_HRCI (int* ijob , const int* n , MKL_Complex8* ze , MKL_Complex8* work , MKL_Complex8* workc , MKL_Complex8* zaq , MKL_Complex8* zsq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , MKL_Complex8* q , int* m , float* res , int* info); extern void __cdecl zfeast_hegv (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HEGV (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl sfeast_srci (int* ijob , const int* n , MKL_Complex8* ze , float* work , MKL_Complex8* workc , float* aq , float* sq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , float* q , int* m , float* res , int* info); extern void __cdecl SFEAST_SRCI (int* ijob , const int* n , MKL_Complex8* ze , float* work , MKL_Complex8* workc , float* aq , float* sq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , float* q , int* m , float* res , int* info); extern void __cdecl dfeast_scsrgv (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , const double* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SCSRGV (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , const double* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl sfeast_syev (const char* uplo , const int* n , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SYEV (const char* uplo , const int* n , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl cfeast_hcsrev (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HCSREV (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl zfeast_hbev (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HBEV (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl dfeast_sbgv (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , const int* klb , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SBGV (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , const int* klb , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl cfeast_hbgv (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , const int* klb , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HBGV (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , const int* klb , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl cfeast_heev (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HEEV (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl sfeast_sbgv (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , const int* klb , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SBGV (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , const int* klb , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl cfeast_hcsrgv (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , const MKL_Complex8* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HCSRGV (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , const MKL_Complex8* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl dfeast_syev (const char* uplo , const int* n , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SYEV (const char* uplo , const int* n , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl dfeast_sbev (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SBEV (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); #line 57 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_direct_call.h" #line 58 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdarg.h" #pragma once __pragma(pack(push, 8)) __pragma(pack(pop)) #line 19 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn_types.h" typedef struct _uniPrimitive_s* dnnPrimitive_t; typedef struct _dnnLayout_s* dnnLayout_t; typedef void* dnnPrimitiveAttributes_t; typedef enum { E_SUCCESS = 0, E_INCORRECT_INPUT_PARAMETER = -1, E_UNEXPECTED_NULL_POINTER = -2, E_MEMORY_ERROR = -3, E_UNSUPPORTED_DIMENSION = -4, E_UNIMPLEMENTED = -127 } dnnError_t; typedef enum { dnnAlgorithmConvolutionGemm, dnnAlgorithmConvolutionDirect, dnnAlgorithmConvolutionFFT, dnnAlgorithmPoolingMax, dnnAlgorithmPoolingMin, dnnAlgorithmPoolingAvgExcludePadding, dnnAlgorithmPoolingAvg = dnnAlgorithmPoolingAvgExcludePadding, dnnAlgorithmPoolingAvgIncludePadding } dnnAlgorithm_t; typedef enum { dnnResourceSrc = 0, dnnResourceFrom = 0, dnnResourceDst = 1, dnnResourceTo = 1, dnnResourceFilter = 2, dnnResourceScaleShift = 2, dnnResourceBias = 3, dnnResourceMean = 3, dnnResourceDiffSrc = 4, dnnResourceDiffFilter = 5, dnnResourceDiffScaleShift = 5, dnnResourceDiffBias = 6, dnnResourceVariance = 6, dnnResourceDiffDst = 7, dnnResourceWorkspace = 8, dnnResourceMultipleSrc = 16, dnnResourceMultipleDst = 24, dnnResourceNumber = 32 } dnnResourceType_t; typedef enum { dnnBorderZeros = 0x0, dnnBorderZerosAsymm = 0x100, dnnBorderExtrapolation = 0x3 } dnnBorder_t; typedef enum { dnnUseInputMeanVariance = 0x1U, dnnUseScaleShift = 0x2U } dnnBatchNormalizationFlag_t; #line 22 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn.h" dnnError_t dnnLayoutCreate_F32( dnnLayout_t *pLayout, size_t dimension, const size_t size[], const size_t strides[]); dnnError_t dnnLayoutCreateFromPrimitive_F32( dnnLayout_t *pLayout, const dnnPrimitive_t primitive, dnnResourceType_t type); size_t dnnLayoutSerializationBufferSize_F32(); dnnError_t dnnLayoutSerialize_F32(const dnnLayout_t layout, void *buf); dnnError_t dnnLayoutDeserialize_F32(dnnLayout_t *pLayout, const void *buf); size_t dnnLayoutGetMemorySize_F32( const dnnLayout_t layout); int dnnLayoutCompare_F32( const dnnLayout_t l1, const dnnLayout_t l2); dnnError_t dnnAllocateBuffer_F32( void **pPtr, dnnLayout_t layout); dnnError_t dnnReleaseBuffer_F32( void *ptr); dnnError_t dnnLayoutDelete_F32( dnnLayout_t layout); dnnError_t dnnPrimitiveAttributesCreate_F32( dnnPrimitiveAttributes_t *attributes); dnnError_t dnnPrimitiveAttributesDestroy_F32( dnnPrimitiveAttributes_t attributes); dnnError_t dnnPrimitiveGetAttributes_F32( dnnPrimitive_t primitive, dnnPrimitiveAttributes_t *attributes); dnnError_t dnnExecute_F32( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnExecuteAsync_F32( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnWaitFor_F32( dnnPrimitive_t primitive); dnnError_t dnnDelete_F32( dnnPrimitive_t primitive); dnnError_t dnnConversionCreate_F32( dnnPrimitive_t* pConversion, const dnnLayout_t from, const dnnLayout_t to); dnnError_t dnnConversionExecute_F32( dnnPrimitive_t conversion, void *from, void *to); dnnError_t dnnSumCreate_F32( dnnPrimitive_t *pSum, dnnPrimitiveAttributes_t attributes, const size_t nSummands, dnnLayout_t layout, float *coefficients); dnnError_t dnnConcatCreate_F32( dnnPrimitive_t* pConcat, dnnPrimitiveAttributes_t attributes, const size_t nSrcTensors, dnnLayout_t *src); dnnError_t dnnSplitCreate_F32( dnnPrimitive_t *pSplit, dnnPrimitiveAttributes_t attributes, const size_t nDstTensors, dnnLayout_t layout, size_t dstChannelSize[]); dnnError_t dnnScaleCreate_F32( dnnPrimitive_t *pScale, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float alpha); dnnError_t dnnConvolutionCreateForward_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateForwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardData_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardFilter_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t dstSize[]); dnnError_t dnnGroupsConvolutionCreateForward_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateForwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardData_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardFilter_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t dstSize[]); dnnError_t dnnReLUCreateForward_F32( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float negativeSlope); dnnError_t dnnReLUCreateBackward_F32( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, float negativeSlope); dnnError_t dnnLRNCreateForward_F32( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, size_t kernel_size, float alpha, float beta, float k); dnnError_t dnnLRNCreateBackward_F32( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, size_t kernel_size, float alpha, float beta, float k); dnnError_t dnnBatchNormalizationCreateForward_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps); dnnError_t dnnBatchNormalizationCreateBackwardScaleShift_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps); dnnError_t dnnBatchNormalizationCreateBackwardData_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps); dnnError_t dnnBatchNormalizationCreateForward_v2_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps, unsigned int flags); dnnError_t dnnBatchNormalizationCreateBackward_v2_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps, unsigned int flags); dnnError_t dnnPoolingCreateForward_F32( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnPoolingCreateBackward_F32( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnInnerProductCreateForward_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateForwardBias_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardData_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardFilter_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardBias_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t dstSize[]); dnnError_t dnnLayoutCreate_F64 ( dnnLayout_t *pLayout, size_t dimension, const size_t size[], const size_t strides[]); dnnError_t dnnLayoutCreateFromPrimitive_F64( dnnLayout_t *pLayout, const dnnPrimitive_t primitive, dnnResourceType_t type); size_t dnnLayoutSerializationBufferSize_F64(); dnnError_t dnnLayoutSerialize_F64(const dnnLayout_t layout, void *buf); dnnError_t dnnLayoutDeserialize_F64(dnnLayout_t *pLayout, const void *buf); size_t dnnLayoutGetMemorySize_F64( const dnnLayout_t layout); int dnnLayoutCompare_F64( const dnnLayout_t l1, const dnnLayout_t l2); dnnError_t dnnAllocateBuffer_F64( void **pPtr, dnnLayout_t layout); dnnError_t dnnReleaseBuffer_F64( void *ptr); dnnError_t dnnLayoutDelete_F64( dnnLayout_t layout); dnnError_t dnnPrimitiveAttributesCreate_F64( dnnPrimitiveAttributes_t *attributes); dnnError_t dnnPrimitiveAttributesDestroy_F64( dnnPrimitiveAttributes_t attributes); dnnError_t dnnPrimitiveGetAttributes_F64( dnnPrimitive_t primitive, dnnPrimitiveAttributes_t *attributes); dnnError_t dnnExecute_F64( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnExecuteAsync_F64( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnWaitFor_F64( dnnPrimitive_t primitive); dnnError_t dnnDelete_F64( dnnPrimitive_t primitive); dnnError_t dnnConversionCreate_F64( dnnPrimitive_t* pConversion, const dnnLayout_t from, const dnnLayout_t to); dnnError_t dnnConversionExecute_F64( dnnPrimitive_t conversion, void *from, void *to); dnnError_t dnnSumCreate_F64( dnnPrimitive_t *pSum, dnnPrimitiveAttributes_t attributes, const size_t nSummands, dnnLayout_t layout, double *coefficients); dnnError_t dnnConcatCreate_F64( dnnPrimitive_t* pConcat, dnnPrimitiveAttributes_t attributes, const size_t nSrcTensors, dnnLayout_t *src); dnnError_t dnnSplitCreate_F64( dnnPrimitive_t *pSplit, dnnPrimitiveAttributes_t attributes, const size_t nDstTensors, dnnLayout_t layout, size_t dstChannelSize[]); dnnError_t dnnScaleCreate_F64( dnnPrimitive_t *pScale, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double alpha); dnnError_t dnnConvolutionCreateForward_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateForwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardData_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardFilter_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t dstSize[]); dnnError_t dnnGroupsConvolutionCreateForward_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateForwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardData_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardFilter_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t dstSize[]); dnnError_t dnnReLUCreateForward_F64( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double negativeSlope); dnnError_t dnnReLUCreateBackward_F64( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, double negativeSlope); dnnError_t dnnLRNCreateForward_F64( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, size_t kernel_size, double alpha, double beta, double k); dnnError_t dnnLRNCreateBackward_F64( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, size_t kernel_size, double alpha, double beta, double k); dnnError_t dnnBatchNormalizationCreateForward_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps); dnnError_t dnnBatchNormalizationCreateBackwardScaleShift_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps); dnnError_t dnnBatchNormalizationCreateBackwardData_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps); dnnError_t dnnBatchNormalizationCreateForward_v2_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps, unsigned int flags); dnnError_t dnnBatchNormalizationCreateBackward_v2_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps, unsigned int flags); dnnError_t dnnPoolingCreateForward_F64( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnPoolingCreateBackward_F64( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnInnerProductCreateForward_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateForwardBias_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardData_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardFilter_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardBias_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t dstSize[]); #line 59 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_compact.h" MKL_COMPACT_PACK mkl_get_format_compact( void ); int mkl_sget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_sgepack_compact( MKL_LAYOUT layout, int rows, int columns, const float * const *a, int lda, float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_sgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, float * const *a, int lda, const float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_sgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, float alpha, const float *ap, int ldap, const float *bp, int ldbp, float beta, float *cp, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_strsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, float alpha, const float *ap, int ldap, float *bp, int ldbp, MKL_COMPACT_PACK format, int nm ); int mkl_dget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_dgepack_compact( MKL_LAYOUT layout, int rows, int columns, const double * const *a, int lda, double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_dgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, double * const *a, int lda, const double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_dgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, double alpha, const double *a, int ldap, const double *b, int ldbp, double beta, double *c, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_dtrsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, double alpha, const double *a, int ldap, double *b, int ldbp, MKL_COMPACT_PACK format, int nm ); int mkl_cget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_cgepack_compact( MKL_LAYOUT layout, int rows, int columns, const MKL_Complex8 * const *a, int lda, float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_cgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, MKL_Complex8 * const *a, int lda, const float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_cgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, const MKL_Complex8 *alpha, const float *a, int ldap, const float *b, int ldbp, const MKL_Complex8 *beta, float *c, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_ctrsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, const MKL_Complex8 *alpha, const float *a, int ldap, float *b, int ldbp, MKL_COMPACT_PACK format, int nm ); int mkl_zget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_zgepack_compact( MKL_LAYOUT layout, int rows, int columns, const MKL_Complex16 * const *a, int lda, double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_zgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, MKL_Complex16 * const *a, int lda, const double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_zgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, const MKL_Complex16 *alpha, const double *a, int ldap, const double *b, int ldbp, const MKL_Complex16 *beta, double *c, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_ztrsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, const MKL_Complex16 *alpha, const double *a, int ldap, double *b, int ldbp, MKL_COMPACT_PACK format, int nm ); void mkl_cgetrinp_compact( MKL_LAYOUT layout, int n, float* ap, int ldap, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dgetrinp_compact( MKL_LAYOUT layout, int n, double* ap, int ldap, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_sgetrinp_compact( MKL_LAYOUT layout, int n, float* ap, int ldap, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zgetrinp_compact( MKL_LAYOUT layout, int n, double* ap, int ldap, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_cgetrfnp_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dgetrfnp_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_sgetrfnp_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zgetrfnp_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_cpotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dpotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_spotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zpotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_cgeqrf_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, float* taup, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dgeqrf_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, double* taup, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_sgeqrf_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, float* taup, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zgeqrf_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, double* taup, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); #line 60 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Checking include with compiler flags var CPPFLAGS [] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef struct _MKL_Complex8 { float real; float imag; } MKL_Complex8; typedef struct _MKL_Complex16 { double real; double imag; } MKL_Complex16; typedef struct { int MajorVersion; int MinorVersion; int UpdateVersion; char * ProductStatus; char * Build; char * Processor; char * Platform; } MKLVersion; #line 65 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 78 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 87 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 103 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 135 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 143 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef enum { MKL_ROW_MAJOR = 101, MKL_COL_MAJOR = 102 } MKL_LAYOUT; typedef enum { MKL_NOTRANS = 111, MKL_TRANS = 112, MKL_CONJTRANS = 113 } MKL_TRANSPOSE; typedef enum { MKL_UPPER = 121, MKL_LOWER = 122 } MKL_UPLO; typedef enum { MKL_NONUNIT = 131, MKL_UNIT = 132 } MKL_DIAG; typedef enum { MKL_LEFT = 141, MKL_RIGHT = 142 } MKL_SIDE; typedef enum { MKL_COMPACT_SSE = 181, MKL_COMPACT_AVX = 182, MKL_COMPACT_AVX512 = 183 } MKL_COMPACT_PACK; #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" #line 35 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" __declspec(deprecated) void mkl_scsrmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scsrsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scscmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scscsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scoomv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scoosv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_sdiamv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sdiasv (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiagemv(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiasymv(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sskymv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sskysv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void mkl_sbsrmv (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sbsrsv(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scsrsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scscmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scscsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scoomm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scoosm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiamm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiasm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskysm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskymm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrsm(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSRSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSCMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSCSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCOOMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCOOSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SDIAMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SDIASV (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIAGEMV(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIASYMV(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SSKYMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SSKYSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void MKL_SBSRMV (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SBSRSV(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIAMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIASM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYSM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRSM(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_dcsrmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcsrsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcscmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcscsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcoomv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcoosv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_ddiamv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_ddiasv (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiagemv(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiasymv(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_dskymv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dskysv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void mkl_dbsrmv (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dbsrsv(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcsrsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoomm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoosm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiamm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiasm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskysm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskymm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrsm(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSRSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSCMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSCSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCOOMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCOOSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DDIAMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DDIASV (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIAGEMV(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIASYMV(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DSKYMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DSKYSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void MKL_DBSRMV (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DBSRSV(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIAMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIASM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYSM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRSM(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ccsrmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoomv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiamv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasv (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiagemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskymv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskysv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccsrsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoosm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiasm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskysm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASV (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIASM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoomv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiamv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasv (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiagemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskymv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskysv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoosm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiasm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskysm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASV (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIASM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_dcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_dcsrcoo(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_ddnscsr(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_dcsrcsc(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_dcsrdia(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_dcsrsky(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_scsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_scsrcoo(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_sdnscsr(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_scsrcsc(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_scsrdia(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_scsrsky(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_ccsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_ccsrcoo(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_cdnscsr(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_ccsrcsc(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_ccsrdia(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_ccsrsky(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_zcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_zcsrcoo(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_zdnscsr(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_zcsrcsc(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_zcsrdia(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_zcsrsky(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_DCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_DCSRCOO(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_DDNSCSR(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_DCSRCSC(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_DCSRDIA(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_DCSRSKY(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_SCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_SCSRCOO(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_SDNSCSR(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_SCSRCSC(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_SCSRDIA(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_SCSRSKY(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_CCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_CCSRCOO(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_CDNSCSR(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_CCSRCSC(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_CCSRDIA(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_CCSRSKY(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_ZCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_ZCSRCOO(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_ZDNSCSR(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_ZCSRCSC(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_ZCSRDIA(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_ZCSRSKY(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_dcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_dcsrmultd(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void mkl_dcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultd(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void mkl_scsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void mkl_ccsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void mkl_zcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTD(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void MKL_DCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTD(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void MKL_SCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void MKL_CCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void MKL_ZCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); typedef enum { SPARSE_STATUS_SUCCESS = 0, SPARSE_STATUS_NOT_INITIALIZED = 1, SPARSE_STATUS_ALLOC_FAILED = 2, SPARSE_STATUS_INVALID_VALUE = 3, SPARSE_STATUS_EXECUTION_FAILED = 4, SPARSE_STATUS_INTERNAL_ERROR = 5, SPARSE_STATUS_NOT_SUPPORTED = 6 } sparse_status_t; typedef enum { SPARSE_OPERATION_NON_TRANSPOSE = 10, SPARSE_OPERATION_TRANSPOSE = 11, SPARSE_OPERATION_CONJUGATE_TRANSPOSE = 12 } sparse_operation_t; typedef enum { SPARSE_MATRIX_TYPE_GENERAL = 20, SPARSE_MATRIX_TYPE_SYMMETRIC = 21, SPARSE_MATRIX_TYPE_HERMITIAN = 22, SPARSE_MATRIX_TYPE_TRIANGULAR = 23, SPARSE_MATRIX_TYPE_DIAGONAL = 24, SPARSE_MATRIX_TYPE_BLOCK_TRIANGULAR = 25, SPARSE_MATRIX_TYPE_BLOCK_DIAGONAL = 26 } sparse_matrix_type_t; typedef enum { SPARSE_INDEX_BASE_ZERO = 0, SPARSE_INDEX_BASE_ONE = 1 } sparse_index_base_t; typedef enum { SPARSE_FILL_MODE_LOWER = 40, SPARSE_FILL_MODE_UPPER = 41, SPARSE_FILL_MODE_FULL = 42 } sparse_fill_mode_t; typedef enum { SPARSE_DIAG_NON_UNIT = 50, SPARSE_DIAG_UNIT = 51 } sparse_diag_type_t; typedef enum { SPARSE_LAYOUT_ROW_MAJOR = 101, SPARSE_LAYOUT_COLUMN_MAJOR = 102 } sparse_layout_t; typedef enum { SPARSE_VERBOSE_OFF = 70, SPARSE_VERBOSE_BASIC = 71, SPARSE_VERBOSE_EXTENDED = 72 } verbose_mode_t; typedef enum { SPARSE_MEMORY_NONE = 80, SPARSE_MEMORY_AGGRESSIVE = 81 } sparse_memory_usage_t; typedef enum { SPARSE_STAGE_FULL_MULT = 90, SPARSE_STAGE_NNZ_COUNT = 91, SPARSE_STAGE_FINALIZE_MULT = 92, SPARSE_STAGE_FULL_MULT_NO_VAL = 93, SPARSE_STAGE_FINALIZE_MULT_NO_VAL = 94 } sparse_request_t; struct sparse_matrix; typedef struct sparse_matrix *sparse_matrix_t; struct matrix_descr { sparse_matrix_type_t type; sparse_fill_mode_t mode; sparse_diag_type_t diag; }; sparse_status_t mkl_sparse_s_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_copy( const sparse_matrix_t source, struct matrix_descr descr, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_destroy( sparse_matrix_t A ); sparse_status_t mkl_sparse_get_error_info( sparse_matrix_t A, int *info ); sparse_status_t mkl_sparse_convert_csr ( const sparse_matrix_t source, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_convert_bsr ( const sparse_matrix_t source, int block_size, sparse_layout_t block_layout, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_s_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_set_value( sparse_matrix_t A, int row, int col, float value ); sparse_status_t mkl_sparse_d_set_value( sparse_matrix_t A, int row, int col, double value ); sparse_status_t mkl_sparse_c_set_value( sparse_matrix_t A, int row, int col, MKL_Complex8 value ); sparse_status_t mkl_sparse_z_set_value( sparse_matrix_t A, int row, int col, MKL_Complex16 value ); sparse_status_t mkl_sparse_set_verbose_mode ( verbose_mode_t verbose ); sparse_status_t mkl_sparse_set_mv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_mm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_sv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_sm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_memory_hint ( sparse_matrix_t A, sparse_memory_usage_t policy ); sparse_status_t mkl_sparse_optimize ( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_mv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y ); sparse_status_t mkl_sparse_d_mv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y ); sparse_status_t mkl_sparse_c_mv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_mv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_trsv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float *y ); sparse_status_t mkl_sparse_d_trsv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double *y ); sparse_status_t mkl_sparse_c_trsv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_trsv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_mm( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float beta, float *y, int ldy ); sparse_status_t mkl_sparse_d_mm( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double beta, double *y, int ldy ); sparse_status_t mkl_sparse_c_mm( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 beta, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_mm( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 beta, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_trsm ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float *y, int ldy ); sparse_status_t mkl_sparse_d_trsm ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double *y, int ldy ); sparse_status_t mkl_sparse_c_trsm ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_trsm ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_add( sparse_operation_t operation, const sparse_matrix_t A, float alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_d_add( sparse_operation_t operation, const sparse_matrix_t A, double alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_c_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_z_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_spmm( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sp2m ( sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, sparse_request_t request, sparse_matrix_t *C ); sparse_status_t mkl_sparse_syrk ( sparse_operation_t operation, const sparse_matrix_t A, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sypr ( sparse_operation_t transA, const sparse_matrix_t A, const sparse_matrix_t B, struct matrix_descr descrB, sparse_matrix_t *C, sparse_request_t request ); sparse_status_t mkl_sparse_s_syprd ( const sparse_operation_t op, const sparse_matrix_t A, float *B, const sparse_layout_t layoutB, const int ldb, float alpha, float beta, float *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_d_syprd ( const sparse_operation_t op, const sparse_matrix_t A, double *B, const sparse_layout_t layoutB, const int ldb, double alpha, double beta, double *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_c_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex8 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_z_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex16 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_order( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, float *C, int ldc ); sparse_status_t mkl_sparse_d_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, double *C, int ldc ); sparse_status_t mkl_sparse_c_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex8 *C, int ldc ); sparse_status_t mkl_sparse_z_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex16 *C, int ldc ); sparse_status_t mkl_sparse_d_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const double alpha, const double beta, double *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_s_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const float alpha, const float beta, float *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_z_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex16 alpha, const MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_c_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex8 alpha, const MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_set_symgs_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_d_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x, double *y); sparse_status_t mkl_sparse_d_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x); sparse_status_t mkl_sparse_set_dotmv_hint( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expectedCalls ); sparse_status_t mkl_sparse_d_dotmv( sparse_operation_t transA, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y, double *d ); sparse_status_t mkl_sparse_s_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x, float *y); sparse_status_t mkl_sparse_s_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x); sparse_status_t mkl_sparse_s_dotmv( sparse_operation_t transA, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y, float *d ); sparse_status_t mkl_sparse_c_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x, MKL_Complex8 *y); sparse_status_t mkl_sparse_c_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x); sparse_status_t mkl_sparse_c_dotmv( sparse_operation_t transA, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y, MKL_Complex8 *d ); sparse_status_t mkl_sparse_z_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x, MKL_Complex16 *y); sparse_status_t mkl_sparse_z_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x); sparse_status_t mkl_sparse_z_dotmv( sparse_operation_t transA, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y, MKL_Complex16 *d ); sparse_status_t mkl_sparse_s_syrkd( sparse_operation_t operation, const sparse_matrix_t A, float alpha, float beta, float *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_d_syrkd( sparse_operation_t operation, const sparse_matrix_t A, double alpha, double beta, double *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_c_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_z_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, sparse_layout_t layout, int ldc ); #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Found header files ['mkl.h', 'mkl_spblas.h'] in [] Popping language C ================================================================================ TEST checksSupportBaijCrossCase from config.packages.mkl_sparse_optimize(/home/alireza/petsc-3.9.3/config/BuildSystem/config/packages/mkl_sparse_optimize.py:21) TESTING: checksSupportBaijCrossCase from config.packages.mkl_sparse_optimize(config/BuildSystem/config/packages/mkl_sparse_optimize.py:21) Determines if MKL Sparse BLAS create routine returns correct status with zero based indexing and columnMajor block layout Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" #include #if STDC_HEADERS #include #include #include #endif #include int main() { FILE *output = fopen("runtimetestoutput","w"); sparse_matrix_t A; int n=1,ia[1],ja[1]; float a[1]; sparse_status_t status = mkl_sparse_s_create_bsr(&A,SPARSE_INDEX_BASE_ZERO,SPARSE_LAYOUT_COLUMN_MAJOR,n,n,n,ia,ia,ja,a); fprintf(output, " '--known-mklspblas-supports-zero-based=%d',\n",(status != SPARSE_STATUS_NOT_SUPPORTED)); ; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib -lm Ws2_32.lib Testing executable /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.exe to see if it can be run Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.exe Executing: /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack/conftest.exe Popping language C Checking for MKL spblas supports zero based indexing: result 1 Defined "MKL_SUPPORTS_BAIJ_ZERO_BASED" to "1" Found MKL spblas supports zero based indexing: result ================================================================================ TEST checkSharedLibrary from config.packages.mkl_sparse_optimize(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:799) TESTING: checkSharedLibrary from config.packages.mkl_sparse_optimize(config/BuildSystem/config/package.py:799) By default we don't care about checking if the library is shared Popping language C Pushing language C ================================================================================ TEST checkDependencies from config.packages.mkl_sparse(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:721) TESTING: checkDependencies from config.packages.mkl_sparse(config/BuildSystem/config/package.py:721) ================================================================================ TEST configureLibrary from config.packages.mkl_sparse(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:746) TESTING: configureLibrary from config.packages.mkl_sparse(config/BuildSystem/config/package.py:746) Find an installation and check if it can work with PETSc ================================================================================== Checking for a functional mkl_sparse Checking for library in Compiler specific search MKL_SPARSE: [] ================================================================================ TEST check from config.libraries(/home/alireza/petsc-3.9.3/config/BuildSystem/config/libraries.py:155) TESTING: check from config.libraries(config/BuildSystem/config/libraries.py:155) Checks that the library "libName" contains "funcs", and if it does defines HAVE_LIB"libName" - libDir may be a list of directories - libName may be a list of library names Checking for functions [mkl_dcsrmv] in library [] ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char mkl_dcsrmv(); static void _check_mkl_dcsrmv() { mkl_dcsrmv(); } int main() { _check_mkl_dcsrmv();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Popping language C Checking for headers Compiler specific search MKL_SPARSE: [] Pushing language C ================================================================================ TEST checkInclude from config.headers(/home/alireza/petsc-3.9.3/config/BuildSystem/config/headers.py:86) TESTING: checkInclude from config.headers(config/BuildSystem/config/headers.py:86) Checks if a particular include file can be found along particular include paths Checking for header files ['mkl.h', 'mkl_spblas.h'] in [] Checking include with compiler flags var CPPFLAGS [] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 32 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_version.h" #line 16 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_version.h" #line 23 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_version.h" #line 38 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef struct _MKL_Complex8 { float real; float imag; } MKL_Complex8; typedef struct _MKL_Complex16 { double real; double imag; } MKL_Complex16; typedef struct { int MajorVersion; int MinorVersion; int UpdateVersion; char * ProductStatus; char * Build; char * Processor; char * Platform; } MKLVersion; #line 65 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 78 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 87 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 103 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 135 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 143 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef enum { MKL_ROW_MAJOR = 101, MKL_COL_MAJOR = 102 } MKL_LAYOUT; typedef enum { MKL_NOTRANS = 111, MKL_TRANS = 112, MKL_CONJTRANS = 113 } MKL_TRANSPOSE; typedef enum { MKL_UPPER = 121, MKL_LOWER = 122 } MKL_UPLO; typedef enum { MKL_NONUNIT = 131, MKL_UNIT = 132 } MKL_DIAG; typedef enum { MKL_LEFT = 141, MKL_RIGHT = 142 } MKL_SIDE; typedef enum { MKL_COMPACT_SSE = 181, MKL_COMPACT_AVX = 182, MKL_COMPACT_AVX512 = 183 } MKL_COMPACT_PACK; #line 39 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_blas.h" void XERBLA(const char *srname, const int *info, const int lsrname); int LSAME(const char *ca, const char *cb, const int lca, const int lcb); float SCABS1(const MKL_Complex8 *c); float SASUM(const int *n, const float *x, const int *incx); void SAXPY(const int *n, const float *alpha, const float *x, const int *incx, float *y, const int *incy); void SAXPBY(const int *n, const float *alpha, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SAXPYI(const int *nz, const float *a, const float *x, const int *indx,float *y); float SCASUM(const int *n, const MKL_Complex8 *x, const int *incx); float SCNRM2(const int *n, const MKL_Complex8 *x, const int *incx); void SCOPY(const int *n, const float *x, const int *incx, float *y, const int *incy); float SDOT(const int *n, const float *x, const int *incx, const float *y, const int *incy); float SDSDOT(const int *n, const float *sb, const float *x, const int *incx, const float *y, const int *incy); float SDOTI(const int *nz, const float *x, const int *indx, const float *y); void SGTHR(const int *nz, const float *y, float *x, const int *indx); void SGTHRZ(const int *nz, float *y, float *x, const int *indx); float SNRM2(const int *n, const float *x, const int *incx); void SROT(const int *n, float *x, const int *incx, float *y, const int *incy, const float *c, const float *s); void SROTG(float *a,float *b,float *c,float *s); void SROTI(const int *nz, float *x, const int *indx, float *y, const float *c, const float *s); void SROTM(const int *n, float *x, const int *incx, float *y, const int *incy, const float *param); void SROTMG(float *d1, float *d2, float *x1, const float *y1, float *param); void SSCAL(const int *n, const float *a, float *x, const int *incx); void SSCTR(const int *nz, const float *x, const int *indx, float *y); void SSWAP(const int *n, float *x, const int *incx, float *y, const int *incy); int ISAMAX(const int *n, const float *x, const int *incx); int ISAMIN(const int *n, const float *x, const int *incx); void CAXPY(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void CAXPBY(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CAXPYI(const int *nz, const MKL_Complex8 *a, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void CCOPY(const int *n, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void CDOTC(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void CDOTCI(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void CDOTU(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void CDOTUI(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void CGTHR(const int *nz, const MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void CGTHRZ(const int *nz, MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void CROTG(MKL_Complex8 *a, const MKL_Complex8 *b, float *c, MKL_Complex8 *s); void CSCAL(const int *n, const MKL_Complex8 *a, MKL_Complex8 *x, const int *incx); void CSCTR(const int *nz, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void CSROT(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy, const float *c, const float *s); void CSSCAL(const int *n, const float *a, MKL_Complex8 *x, const int *incx); void CSWAP(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); int ICAMAX(const int *n, const MKL_Complex8 *x, const int *incx); int ICAMIN(const int *n, const MKL_Complex8 *x, const int *incx); double DCABS1(const MKL_Complex16 *z); double DASUM(const int *n, const double *x, const int *incx); void DAXPY(const int *n, const double *alpha, const double *x, const int *incx, double *y, const int *incy); void DAXPBY(const int *n, const double *alpha, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DAXPYI(const int *nz, const double *a, const double *x, const int *indx, double *y); void DCOPY(const int *n, const double *x, const int *incx, double *y, const int *incy); double DDOT(const int *n, const double *x, const int *incx, const double *y, const int *incy); double DSDOT(const int *n, const float *x, const int *incx, const float *y, const int *incy); double DDOTI(const int *nz, const double *x, const int *indx, const double *y); void DGTHR(const int *nz, const double *y, double *x, const int *indx); void DGTHRZ(const int *nz, double *y, double *x, const int *indx); double DNRM2(const int *n, const double *x, const int *incx); void DROT(const int *n, double *x, const int *incx, double *y, const int *incy, const double *c, const double *s); void DROTG(double *a,double *b,double *c,double *s); void DROTI(const int *nz, double *x, const int *indx, double *y, const double *c, const double *s); void DROTM(const int *n, double *x, const int *incx, double *y, const int *incy, const double *param); void DROTMG(double *d1, double *d2, double *x1, const double *y1, double *param); void DSCAL(const int *n, const double *a, double *x, const int *incx); void DSCTR(const int *nz, const double *x, const int *indx, double *y); void DSWAP(const int *n, double *x, const int *incx, double *y, const int *incy); double DZASUM(const int *n, const MKL_Complex16 *x, const int *incx); double DZNRM2(const int *n, const MKL_Complex16 *x, const int *incx); int IDAMAX(const int *n, const double *x, const int *incx); int IDAMIN(const int *n, const double *x, const int *incx); void ZAXPY(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void ZAXPBY(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZAXPYI(const int *nz, const MKL_Complex16 *a, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void ZCOPY(const int *n, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void ZDOTC(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void ZDOTCI(MKL_Complex16 *pres,const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void ZDOTU(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void ZDOTUI(MKL_Complex16 *pres, const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void ZDROT(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy, const double *c, const double *s); void ZDSCAL(const int *n, const double *a, MKL_Complex16 *x, const int *incx); void ZGTHR(const int *nz, const MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void ZGTHRZ(const int *nz, MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void ZROTG(MKL_Complex16 *a, const MKL_Complex16 *b, double *c, MKL_Complex16 *s); void ZSCAL(const int *n, const MKL_Complex16 *a, MKL_Complex16 *x, const int *incx); void ZSCTR(const int *nz, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void ZSWAP(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); int IZAMAX(const int *n, const MKL_Complex16 *x, const int *incx); int IZAMIN(const int *n,const MKL_Complex16 *x, const int *incx); void SGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SGEMV(const char *trans, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SGER(const int *m, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void SSBMV(const char *uplo, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SSPMV(const char *uplo, const int *n, const float *alpha, const float *ap, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SSPR(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *ap); void SSPR2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *ap); void SSYMV(const char *uplo, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void SSYR(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *a, const int *lda); void SSYR2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void STBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void STBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void STPMV(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void STPSV(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void STRMV(const char *uplo, const char *transa, const char *diag, const int *n, const float *a, const int *lda, float *b, const int *incx); void STRSV(const char *uplo, const char *trans, const char *diag, const int *n, const float *a, const int *lda, float *x, const int *incx); void SGEM2VU(const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x1, const int *incx1, const float *x2, const int *incx2, const float *beta, float *y1, const int *incy1, float *y2, const int *incy2); void CGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CGEMV(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CGERC(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void CGERU(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void CHBMV(const char *uplo, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CHEMV(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CHER(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *a, const int *lda); void CHER2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void CHPMV(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *ap, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void CHPR(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *ap); void CHPR2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *ap); void CTBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void CTBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void CTPMV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void CTPSV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void CTRMV(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *incx); void CTRSV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void CGEM2VC(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x1, const int *incx1, const MKL_Complex8 *x2, const int *incx2, const MKL_Complex8 *beta, MKL_Complex8 *y1, const int *incy1, MKL_Complex8 *y2, const int *incy2); void SCGEMV(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void DGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DGEMV(const char *trans, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DGER(const int *m, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void DSBMV(const char *uplo, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DSPMV(const char *uplo, const int *n, const double *alpha, const double *ap, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DSPR(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *ap); void DSPR2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *ap); void DSYMV(const char *uplo, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void DSYR(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *a, const int *lda); void DSYR2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void DTBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void DTBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void DTPMV(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void DTPSV(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void DTRMV(const char *uplo, const char *transa, const char *diag, const int *n, const double *a, const int *lda, double *b, const int *incx); void DTRSV(const char *uplo, const char *trans, const char *diag, const int *n, const double *a, const int *lda, double *x, const int *incx); void DGEM2VU(const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x1, const int *incx1, const double *x2, const int *incx2, const double *beta, double *y1, const int *incy1, double *y2, const int *incy2); void ZGBMV(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZGEMV(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZGERC(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void ZGERU(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void ZHBMV(const char *uplo, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZHEMV(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZHER(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *a, const int *lda); void ZHER2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void ZHPMV(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *ap, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void ZHPR(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *ap); void ZHPR2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *ap); void ZTBMV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ZTBSV(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ZTPMV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ZTPSV(const char *uplo, const char *trans, const char *diag, const int *n, MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ZTRMV(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *incx); void ZTRSV(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ZGEM2VC(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x1, const int *incx1, const MKL_Complex16 *x2, const int *incx2, const MKL_Complex16 *beta, MKL_Complex16 *y1, const int *incy1, MKL_Complex16 *y2, const int *incy2); void DZGEMV(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void SGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); float* SGEMM_ALLOC(const char *identifier, const int *m, const int *n, const int *k); void SGEMM_PACK(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const float *alpha, const float *src, const int *ld, float *dest); void SGEMM_COMPUTE(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SGEMM_FREE(float *mat); void SGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const float *alpha_array, const float **a_array, const int *lda_array, const float **b_array, const int *ldb_array, const float *beta_array, float **c_array, const int *ldc_array, const int *group_count, const int *group_size); void SGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SSYMM(const char *side, const char *uplo, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void SSYRK(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *beta, float *c, const int *ldc); void STRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void STRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void STRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const float *alpha_array, const float **a_array, const int *lda_array, float **b_array, const int *ldb, const int *group_count, const int *group_size); void CGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void SCGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CGEMM3M(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CGEMM3M_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void CGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CHEMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CHER2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const float *beta, MKL_Complex8 *c, const int *ldc); void CHERK(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const MKL_Complex8 *a, const int *lda, const float *beta, MKL_Complex8 *c, const int *ldc); void CSYMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CSYRK(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void CTRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void CTRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void CTRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, MKL_Complex8 **b_array, const int *ldb, const int *group_count, const int *group_size); void DGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); double* DGEMM_ALLOC(const char *identifier, const int *m, const int *n, const int *k); void DGEMM_PACK(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const double *alpha, const double *src, const int *ld, double *dest); void DGEMM_COMPUTE(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void DGEMM_FREE(double *mat); void DGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const double *alpha_array, const double **a_array, const int *lda_array, const double **b_array, const int *ldb_array, const double *beta_array, double **c_array, const int *ldc_array, const int *group_count, const int *group_size); void DGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, double *beta, double *c, const int *ldc); void DSYMM(const char *side, const char *uplo, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void DSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, double *beta, double *c, const int *ldc); void DSYRK(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *beta, double *c, const int *ldc); void DTRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void DTRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void DTRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const double *alpha_array, const double **a_array, const int *lda_array, double **b_array, const int *ldb, const int *group_count, const int *group_size); void ZGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZGEMM_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void DZGEMM(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZGEMM3M(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZGEMM3M_BATCH(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void ZGEMMT(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZHEMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZHER2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const double *beta, MKL_Complex16 *c, const int *ldc); void ZHERK(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const MKL_Complex16 *a, const int *lda, const double *beta, MKL_Complex16 *c, const int *ldc); void ZSYMM(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZSYR2K(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZSYRK(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ZTRMM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ZTRSM(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ZTRSM_BATCH(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, MKL_Complex16 **b_array, const int *ldb, const int *group_count, const int *group_size); void GEMM_S8U8S32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const char *a, const int *lda, const char *ao, const unsigned char *b, const int *ldb, const char *bo, const float *beta, int *c, const int *ldc, const int *co); void GEMM_S16S16S32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const short *a, const int *lda, const short *ao, const short *b, const int *ldb, const short *bo, const float *beta, int *c, const int *ldc, const int *co); void xerbla(const char *srname, const int *info, const int lsrname); int lsame(const char *ca, const char *cb, const int lca, const int lcb); float scabs1(const MKL_Complex8 *c); float sasum(const int *n, const float *x, const int *incx); void saxpy(const int *n, const float *alpha, const float *x, const int *incx, float *y, const int *incy); void saxpby(const int *n, const float *alpha, const float *x, const int *incx, const float *beta, float *y, const int *incy); void saxpyi(const int *nz, const float *a, const float *x, const int *indx, float *y); float scasum(const int *n, const MKL_Complex8 *x, const int *incx); float scnrm2(const int *n, const MKL_Complex8 *x, const int *incx); void scopy(const int *n, const float *x, const int *incx, float *y, const int *incy); float sdot(const int *n, const float *x, const int *incx, const float *y, const int *incy); float sdoti(const int *nz, const float *x, const int *indx, const float *y); float sdsdot(const int *n, const float *sb, const float *x, const int *incx, const float *y, const int *incy); void sgthr(const int *nz, const float *y, float *x, const int *indx); void sgthrz(const int *nz, float *y, float *x, const int *indx); float snrm2(const int *n, const float *x, const int *incx); void srot(const int *n, float *x, const int *incx, float *y, const int *incy, const float *c, const float *s); void srotg(float *a,float *b,float *c,float *s); void sroti(const int *nz, float *x, const int *indx, float *y, const float *c, const float *s); void srotm(const int *n, float *x, const int *incx, float *y, const int *incy, const float *param); void srotmg(float *d1, float *d2, float *x1, const float *y1, float *param); void sscal(const int *n, const float *a, float *x, const int *incx); void ssctr(const int *nz, const float *x, const int *indx, float *y); void sswap(const int *n, float *x, const int *incx, float *y, const int *incy); int isamax(const int *n, const float *x, const int *incx); int isamin(const int *n, const float *x, const int *incx); void caxpy(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void caxpby(const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void caxpyi(const int *nz, const MKL_Complex8 *a, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void ccopy(const int *n, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); void cdotc(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void cdotci(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void cdotu(MKL_Complex8 *pres, const int *n, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy); void cdotui(MKL_Complex8 *pres, const int *nz, const MKL_Complex8 *x, const int *indx, const MKL_Complex8 *y); void cgthr(const int *nz, const MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void cgthrz(const int *nz, MKL_Complex8 *y, MKL_Complex8 *x, const int *indx); void crotg(MKL_Complex8 *a, const MKL_Complex8 *b, float *c, MKL_Complex8 *s); void cscal(const int *n, const MKL_Complex8 *a, MKL_Complex8 *x, const int *incx); void csctr(const int *nz, const MKL_Complex8 *x, const int *indx, MKL_Complex8 *y); void csrot(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy, const float *c, const float *s); void csscal(const int *n, const float *a, MKL_Complex8 *x, const int *incx); void cswap(const int *n, MKL_Complex8 *x, const int *incx, MKL_Complex8 *y, const int *incy); int icamax(const int *n, const MKL_Complex8 *x, const int *incx); int icamin(const int *n, const MKL_Complex8 *x, const int *incx); double dcabs1(const MKL_Complex16 *z); double dasum(const int *n, const double *x, const int *incx); void daxpy(const int *n, const double *alpha, const double *x, const int *incx, double *y, const int *incy); void daxpby(const int *n, const double *alpha, const double *x, const int *incx, const double *beta, double *y, const int *incy); void daxpyi(const int *nz, const double *a, const double *x, const int *indx, double *y); void dcopy(const int *n, const double *x, const int *incx, double *y, const int *incy); double ddot(const int *n, const double *x, const int *incx, const double *y, const int *incy); double dsdot(const int *n, const float *x, const int *incx, const float *y, const int *incy); double ddoti(const int *nz, const double *x, const int *indx, const double *y); void dgthr(const int *nz, const double *y, double *x, const int *indx); void dgthrz(const int *nz, double *y, double *x, const int *indx); double dnrm2(const int *n, const double *x, const int *incx); void drot(const int *n, double *x, const int *incx, double *y, const int *incy, const double *c, const double *s); void drotg(double *a, double *b, double *c, double *s); void droti(const int *nz, double *x, const int *indx, double *y, const double *c, const double *s); void drotm(const int *n, double *x, const int *incx, double *y, const int *incy, const double *param); void drotmg(double *d1, double *d2, double *x1, const double *y1, double *param); void dscal(const int *n, const double *a, double *x, const int *incx); void dsctr(const int *nz, const double *x, const int *indx, double *y); void dswap(const int *n, double *x, const int *incx, double *y, const int *incy); double dzasum(const int *n, const MKL_Complex16 *x, const int *incx); double dznrm2(const int *n, const MKL_Complex16 *x, const int *incx); int idamax(const int *n, const double *x, const int *incx); int idamin(const int *n, const double *x, const int *incx); void zaxpy(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void zaxpby(const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zaxpyi(const int *nz, const MKL_Complex16 *a, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void zcopy(const int *n, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); void zdotc(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void zdotci(MKL_Complex16 *pres, const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void zdotu(MKL_Complex16 *pres, const int *n, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy); void zdotui(MKL_Complex16 *pres, const int *nz, const MKL_Complex16 *x, const int *indx, const MKL_Complex16 *y); void zdrot(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy, const double *c, const double *s); void zdscal(const int *n, const double *a, MKL_Complex16 *x, const int *incx); void zgthr(const int *nz, const MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void zgthrz(const int *nz, MKL_Complex16 *y, MKL_Complex16 *x, const int *indx); void zrotg(MKL_Complex16 *a, const MKL_Complex16 *b, double *c, MKL_Complex16 *s); void zscal(const int *n, const MKL_Complex16 *a, MKL_Complex16 *x, const int *incx); void zsctr(const int *nz, const MKL_Complex16 *x, const int *indx, MKL_Complex16 *y); void zswap(const int *n, MKL_Complex16 *x, const int *incx, MKL_Complex16 *y, const int *incy); int izamax(const int *n, const MKL_Complex16 *x, const int *incx); int izamin(const int *n, const MKL_Complex16 *x, const int *incx); void sgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sgemv(const char *trans, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sger(const int *m, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void ssbmv(const char *uplo, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sspmv(const char *uplo, const int *n, const float *alpha, const float *ap, const float *x, const int *incx, const float *beta, float *y, const int *incy); void sspr(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *ap); void sspr2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *ap); void ssymv(const char *uplo, const int *n, const float *alpha, const float *a, const int *lda, const float *x, const int *incx, const float *beta, float *y, const int *incy); void ssyr(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, float *a, const int *lda); void ssyr2(const char *uplo, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda); void stbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void stbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const float *a, const int *lda, float *x, const int *incx); void stpmv(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void stpsv(const char *uplo, const char *trans, const char *diag, const int *n, const float *ap, float *x, const int *incx); void strmv(const char *uplo, const char *transa, const char *diag, const int *n, const float *a, const int *lda, float *b, const int *incx); void strsv(const char *uplo, const char *trans, const char *diag, const int *n, const float *a, const int *lda, float *x, const int *incx); void sgem2vu(const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *x1, const int *incx1, const float *x2, const int *incx2, const float *beta, float *y1, const int *incy1, float *y2, const int *incy2); void cgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void cgemv(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void cgerc(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void cgeru(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void chbmv(const char *uplo, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void chemv(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void cher(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *a, const int *lda); void cher2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *a, const int *lda); void chpmv(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *ap, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void chpr(const char *uplo, const int *n, const float *alpha, const MKL_Complex8 *x, const int *incx, MKL_Complex8 *ap); void chpr2(const char *uplo, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *y, const int *incy, MKL_Complex8 *ap); void ctbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void ctbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void ctpmv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void ctpsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *ap, MKL_Complex8 *x, const int *incx); void ctrmv(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *incx); void ctrsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *x, const int *incx); void cgem2vc(const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *x1, const int *incx1, const MKL_Complex8 *x2, const int *incx2, const MKL_Complex8 *beta, MKL_Complex8 *y1, const int *incy1, MKL_Complex8 *y2, const int *incy2); void scgemv(const char *trans, const int *m, const int *n, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *x, const int *incx, const MKL_Complex8 *beta, MKL_Complex8 *y, const int *incy); void dgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dgemv(const char *trans, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dger(const int *m, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void dsbmv(const char *uplo, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dspmv(const char *uplo, const int *n, const double *alpha, const double *ap, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dspr(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *ap); void dspr2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *ap); void dsymv(const char *uplo, const int *n, const double *alpha, const double *a, const int *lda, const double *x, const int *incx, const double *beta, double *y, const int *incy); void dsyr(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, double *a, const int *lda); void dsyr2(const char *uplo, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda); void dtbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void dtbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const double *a, const int *lda, double *x, const int *incx); void dtpmv(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void dtpsv(const char *uplo, const char *trans, const char *diag, const int *n, const double *ap, double *x, const int *incx); void dtrmv(const char *uplo, const char *transa, const char *diag, const int *n, const double *a, const int *lda, double *b, const int *incx); void dtrsv(const char *uplo, const char *trans, const char *diag, const int *n, const double *a, const int *lda, double *x, const int *incx); void dgem2vu(const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *x1, const int *incx1, const double *x2, const int *incx2, const double *beta, double *y1, const int *incy1, double *y2, const int *incy2); void zgbmv(const char *trans, const int *m, const int *n, const int *kl, const int *ku, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zgemv(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zgerc(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void zgeru(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void zhbmv(const char *uplo, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zhemv(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zher(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *a, const int *lda); void zher2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *a, const int *lda); void zhpmv(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *ap, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void zhpr(const char *uplo, const int *n, const double *alpha, const MKL_Complex16 *x, const int *incx, MKL_Complex16 *ap); void zhpr2(const char *uplo, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *y, const int *incy, MKL_Complex16 *ap); void ztbmv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ztbsv(const char *uplo, const char *trans, const char *diag, const int *n, const int *k, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void ztpmv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ztpsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *ap, MKL_Complex16 *x, const int *incx); void ztrmv(const char *uplo, const char *transa, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *incx); void ztrsv(const char *uplo, const char *trans, const char *diag, const int *n, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *x, const int *incx); void zgem2vc(const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *x1, const int *incx1, const MKL_Complex16 *x2, const int *incx2, const MKL_Complex16 *beta, MKL_Complex16 *y1, const int *incy1, MKL_Complex16 *y2, const int *incy2); void dzgemv(const char *trans, const int *m, const int *n, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *x, const int *incx, const MKL_Complex16 *beta, MKL_Complex16 *y, const int *incy); void sgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); float* sgemm_alloc(const char *identifier, const int *m, const int *n, const int *k); void sgemm_pack(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const float *alpha, const float *src, const int *ld, float *dest); void sgemm_compute(const char *transa, const char *transb, const int *m, const int *n, const int *k, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void sgemm_free(float *mat); void sgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const float *alpha_array, const float **a_array, const int *lda_array, const float **b_array, const int *ldb_array, const float *beta_array, float **c_array, const int *ldc_array, const int *group_count, const int *group_size); void sgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void ssymm(const char *side, const char *uplo, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void ssyr2k(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); void ssyrk(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *beta, float *c, const int *ldc); void strmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void strsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb); void strsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const float *alpha_array, const float **a_array, const int *lda_array, float **b_array, const int *ldb, const int *group_count, const int *group_size); void cgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void scgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const float *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cgemm3m(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cgemm3m_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, const MKL_Complex8 **b_array, const int *ldb_array, const MKL_Complex8 *beta_array, MKL_Complex8 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void cgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void chemm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void cher2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const float *beta, MKL_Complex8 *c, const int *ldc); void cherk(const char *uplo, const char *trans, const int *n, const int *k, const float *alpha, const MKL_Complex8 *a, const int *lda, const float *beta, MKL_Complex8 *c, const int *ldc); void csymm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void csyr2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void csyrk(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); void ctrmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void ctrsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex8 *alpha, const MKL_Complex8 *a, const int *lda, MKL_Complex8 *b, const int *ldb); void ctrsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex8 *alpha_array, const MKL_Complex8 **a_array, const int *lda_array, MKL_Complex8 **b_array, const int *ldb, const int *group_count, const int *group_size); void dgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); double* dgemm_alloc(const char *identifier, const int *m, const int *n, const int *k); void dgemm_pack(const char *identifier, const char *trans, const int *m, const int *n, const int *k, const double *alpha, const double *src, const int *ld, double *dest); void dgemm_compute(const char *transa, const char *transb, const int *m, const int *n, const int *k, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dgemm_free(double *mat); void dgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const double *alpha_array, const double **a_array, const int *lda_array, const double **b_array, const int *ldb_array, const double *beta_array, double **c_array, const int *ldc_array, const int *group_count, const int *group_size); void dgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dsymm(const char *side, const char *uplo, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dsyr2k(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); void dsyrk(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *beta, double *c, const int *ldc); void dtrmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void dtrsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb); void dtrsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const double *alpha_array, const double **a_array, const int *lda_array, double **b_array, const int *ldb, const int *group_count, const int *group_size); void zgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zgemm_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void dzgemm(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const double *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zgemm3m(const char *transa, const char *transb, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zgemm3m_batch(const char *transa_array, const char *transb_array, const int *m_array, const int *n_array, const int *k_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, const MKL_Complex16 **b_array, const int *ldb_array, const MKL_Complex16 *beta_array, MKL_Complex16 **c_array, const int *ldc_array, const int *group_count, const int *group_size); void zgemmt(const char *uplo, const char *transa, const char *transb, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zhemm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zher2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const double *beta, MKL_Complex16 *c, const int *ldc); void zherk(const char *uplo, const char *trans, const int *n, const int *k, const double *alpha, const MKL_Complex16 *a, const int *lda, const double *beta, MKL_Complex16 *c, const int *ldc); void zsymm(const char *side, const char *uplo, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zsyr2k(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void zsyrk(const char *uplo, const char *trans, const int *n, const int *k, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); void ztrmm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ztrsm(const char *side, const char *uplo, const char *transa, const char *diag, const int *m, const int *n, const MKL_Complex16 *alpha, const MKL_Complex16 *a, const int *lda, MKL_Complex16 *b, const int *ldb); void ztrsm_batch(const char *side_array, const char *uplo_array, const char *transa_array, const char *diag_array, const int *m_array, const int *n_array, const MKL_Complex16 *alpha_array, const MKL_Complex16 **a_array, const int *lda_array, MKL_Complex16 **b_array, const int *ldb, const int *group_count, const int *group_size); void gemm_s8u8s32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const char *a, const int *lda, const char *ao, const unsigned char *b, const int *ldb, const char *bo, const float *beta, int *c, const int *ldc, const int *co); void gemm_s16s16s32(const char *transa, const char *transb, const char *offsetc, const int *m, const int *n, const int *k, const float *alpha, const short *a, const int *lda, const short *ao, const short *b, const int *ldb, const short *bo, const float *beta, int *c, const int *ldc, const int *co); #line 40 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_trans.h" void MKL_Simatcopy( const char ordering, const char trans, size_t rows, size_t cols, const float alpha, float * AB, size_t lda, size_t ldb); void MKL_Dimatcopy( const char ordering, const char trans, size_t rows, size_t cols, const double alpha, double * AB, size_t lda, size_t ldb); void MKL_Cimatcopy( const char ordering, const char trans, size_t rows, size_t cols, const MKL_Complex8 alpha, MKL_Complex8 * AB, size_t lda, size_t ldb); void MKL_Zimatcopy( const char ordering, const char trans, size_t rows, size_t cols, const MKL_Complex16 alpha, MKL_Complex16 * AB, size_t lda, size_t ldb); void MKL_Somatcopy( char ordering, char trans, size_t rows, size_t cols, const float alpha, const float * A, size_t lda, float * B, size_t ldb); void MKL_Domatcopy( char ordering, char trans, size_t rows, size_t cols, const double alpha, const double * A, size_t lda, double * B, size_t ldb); void MKL_Comatcopy( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex8 alpha, const MKL_Complex8 * A, size_t lda, MKL_Complex8 * B, size_t ldb); void MKL_Zomatcopy( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex16 alpha, const MKL_Complex16 * A, size_t lda, MKL_Complex16 * B, size_t ldb); void MKL_Somatcopy2( char ordering, char trans, size_t rows, size_t cols, const float alpha, const float * A, size_t lda, size_t stridea, float * B, size_t ldb, size_t strideb); void MKL_Domatcopy2( char ordering, char trans, size_t rows, size_t cols, const double alpha, const double * A, size_t lda, size_t stridea, double * B, size_t ldb, size_t strideb); void MKL_Comatcopy2( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex8 alpha, const MKL_Complex8 * A, size_t lda, size_t stridea, MKL_Complex8 * B, size_t ldb, size_t strideb); void MKL_Zomatcopy2( char ordering, char trans, size_t rows, size_t cols, const MKL_Complex16 alpha, const MKL_Complex16 * A, size_t lda, size_t stridea, MKL_Complex16 * B, size_t ldb, size_t strideb); void MKL_Somatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const float alpha, const float * A, size_t lda, const float beta, const float * B, size_t ldb, float * C, size_t ldc); void MKL_Domatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const double alpha, const double * A, size_t lda, const double beta, const double * B, size_t ldb, double * C, size_t ldc); void MKL_Comatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const MKL_Complex8 alpha, const MKL_Complex8 * A, size_t lda, const MKL_Complex8 beta, const MKL_Complex8 * B, size_t ldb, MKL_Complex8 * C, size_t ldc); void MKL_Zomatadd( char ordering, char transa, char transb, size_t rows, size_t cols, const MKL_Complex16 alpha, const MKL_Complex16 * A, size_t lda, const MKL_Complex16 beta, const MKL_Complex16 * B, size_t ldb, MKL_Complex16 * C, size_t ldc); #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_cblas.h" #line 37 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_cblas.h" typedef enum {CblasRowMajor=101, CblasColMajor=102} CBLAS_LAYOUT; typedef enum {CblasNoTrans=111, CblasTrans=112, CblasConjTrans=113} CBLAS_TRANSPOSE; typedef enum {CblasUpper=121, CblasLower=122} CBLAS_UPLO; typedef enum {CblasNonUnit=131, CblasUnit=132} CBLAS_DIAG; typedef enum {CblasLeft=141, CblasRight=142} CBLAS_SIDE; typedef enum {CblasPacked=151} CBLAS_STORAGE; typedef enum {CblasAMatrix=161, CblasBMatrix=162} CBLAS_IDENTIFIER; typedef enum {CblasRowOffset=171, CblasColOffset=172, CblasFixOffset=173} CBLAS_OFFSET; typedef CBLAS_LAYOUT CBLAS_ORDER; double cblas_dcabs1(const void *z); float cblas_scabs1(const void *c); float cblas_sdot(const int N, const float *X, const int incX, const float *Y, const int incY); float cblas_sdoti(const int N, const float *X, const int *indx, const float *Y); double cblas_ddot(const int N, const double *X, const int incX, const double *Y, const int incY); double cblas_ddoti(const int N, const double *X, const int *indx, const double *Y); double cblas_dsdot(const int N, const float *X, const int incX, const float *Y, const int incY); float cblas_sdsdot(const int N, const float sb, const float *X, const int incX, const float *Y, const int incY); void cblas_cdotu_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotu); void cblas_cdotui_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); void cblas_cdotc_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotc); void cblas_cdotci_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); void cblas_zdotu_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotu); void cblas_zdotui_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); void cblas_zdotc_sub(const int N, const void *X, const int incX, const void *Y, const int incY, void *dotc); void cblas_zdotci_sub(const int N, const void *X, const int *indx, const void *Y, void *dotui); float cblas_snrm2(const int N, const float *X, const int incX); float cblas_sasum(const int N, const float *X, const int incX); double cblas_dnrm2(const int N, const double *X, const int incX); double cblas_dasum(const int N, const double *X, const int incX); float cblas_scnrm2(const int N, const void *X, const int incX); float cblas_scasum(const int N, const void *X, const int incX); double cblas_dznrm2(const int N, const void *X, const int incX); double cblas_dzasum(const int N, const void *X, const int incX); size_t cblas_isamax(const int N, const float *X, const int incX); size_t cblas_idamax(const int N, const double *X, const int incX); size_t cblas_icamax(const int N, const void *X, const int incX); size_t cblas_izamax(const int N, const void *X, const int incX); size_t cblas_isamin(const int N, const float *X, const int incX); size_t cblas_idamin(const int N, const double *X, const int incX); size_t cblas_icamin(const int N, const void *X, const int incX); size_t cblas_izamin(const int N, const void *X, const int incX); void cblas_sswap(const int N, float *X, const int incX, float *Y, const int incY); void cblas_scopy(const int N, const float *X, const int incX, float *Y, const int incY); void cblas_saxpy(const int N, const float alpha, const float *X, const int incX, float *Y, const int incY); void cblas_saxpby(const int N, const float alpha, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_saxpyi(const int N, const float alpha, const float *X, const int *indx, float *Y); void cblas_sgthr(const int N, const float *Y, float *X, const int *indx); void cblas_sgthrz(const int N, float *Y, float *X, const int *indx); void cblas_ssctr(const int N, const float *X, const int *indx, float *Y); void cblas_srotg(float *a, float *b, float *c, float *s); void cblas_dswap(const int N, double *X, const int incX, double *Y, const int incY); void cblas_dcopy(const int N, const double *X, const int incX, double *Y, const int incY); void cblas_daxpy(const int N, const double alpha, const double *X, const int incX, double *Y, const int incY); void cblas_daxpby(const int N, const double alpha, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_daxpyi(const int N, const double alpha, const double *X, const int *indx, double *Y); void cblas_dgthr(const int N, const double *Y, double *X, const int *indx); void cblas_dgthrz(const int N, double *Y, double *X, const int *indx); void cblas_dsctr(const int N, const double *X, const int *indx, double *Y); void cblas_drotg(double *a, double *b, double *c, double *s); void cblas_cswap(const int N, void *X, const int incX, void *Y, const int incY); void cblas_ccopy(const int N, const void *X, const int incX, void *Y, const int incY); void cblas_caxpy(const int N, const void *alpha, const void *X, const int incX, void *Y, const int incY); void cblas_caxpby(const int N, const void *alpha, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_caxpyi(const int N, const void *alpha, const void *X, const int *indx, void *Y); void cblas_cgthr(const int N, const void *Y, void *X, const int *indx); void cblas_cgthrz(const int N, void *Y, void *X, const int *indx); void cblas_csctr(const int N, const void *X, const int *indx, void *Y); void cblas_crotg(void *a, const void *b, float *c, void *s); void cblas_zswap(const int N, void *X, const int incX, void *Y, const int incY); void cblas_zcopy(const int N, const void *X, const int incX, void *Y, const int incY); void cblas_zaxpy(const int N, const void *alpha, const void *X, const int incX, void *Y, const int incY); void cblas_zaxpby(const int N, const void *alpha, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zaxpyi(const int N, const void *alpha, const void *X, const int *indx, void *Y); void cblas_zgthr(const int N, const void *Y, void *X, const int *indx); void cblas_zgthrz(const int N, void *Y, void *X, const int *indx); void cblas_zsctr(const int N, const void *X, const int *indx, void *Y); void cblas_zrotg(void *a, const void *b, double *c, void *s); void cblas_srotmg(float *d1, float *d2, float *b1, const float b2, float *P); void cblas_srot(const int N, float *X, const int incX, float *Y, const int incY, const float c, const float s); void cblas_sroti(const int N, float *X, const int *indx, float *Y, const float c, const float s); void cblas_srotm(const int N, float *X, const int incX, float *Y, const int incY, const float *P); void cblas_drotmg(double *d1, double *d2, double *b1, const double b2, double *P); void cblas_drot(const int N, double *X, const int incX, double *Y, const int incY, const double c, const double s); void cblas_drotm(const int N, double *X, const int incX, double *Y, const int incY, const double *P); void cblas_droti(const int N, double *X, const int *indx, double *Y, const double c, const double s); void cblas_csrot(const int N, void *X, const int incX, void *Y, const int incY, const float c, const float s); void cblas_zdrot(const int N, void *X, const int incX, void *Y, const int incY, const double c, const double s); void cblas_sscal(const int N, const float alpha, float *X, const int incX); void cblas_dscal(const int N, const double alpha, double *X, const int incX); void cblas_cscal(const int N, const void *alpha, void *X, const int incX); void cblas_zscal(const int N, const void *alpha, void *X, const int incX); void cblas_csscal(const int N, const float alpha, void *X, const int incX); void cblas_zdscal(const int N, const double alpha, void *X, const int incX); void cblas_sgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_sgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_strmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *A, const int lda, float *X, const int incX); void cblas_stbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const float *A, const int lda, float *X, const int incX); void cblas_stpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *Ap, float *X, const int incX); void cblas_strsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *A, const int lda, float *X, const int incX); void cblas_stbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const float *A, const int lda, float *X, const int incX); void cblas_stpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const float *Ap, float *X, const int incX); void cblas_dgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dtrmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *A, const int lda, double *X, const int incX); void cblas_dtbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const double *A, const int lda, double *X, const int incX); void cblas_dtpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *Ap, double *X, const int incX); void cblas_dtrsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *A, const int lda, double *X, const int incX); void cblas_dtbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const double *A, const int lda, double *X, const int incX); void cblas_dtpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const double *Ap, double *X, const int incX); void cblas_cgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_cgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_ctrmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ctbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ctpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_ctrsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ctbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ctpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_zgemv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zgbmv(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const int M, const int N, const int KL, const int KU, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_ztrmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ztbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ztpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_ztrsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *A, const int lda, void *X, const int incX); void cblas_ztbsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const int K, const void *A, const int lda, void *X, const int incX); void cblas_ztpsv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int N, const void *Ap, void *X, const int incX); void cblas_ssymv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_ssbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const float alpha, const float *A, const int lda, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_sspmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *Ap, const float *X, const int incX, const float beta, float *Y, const int incY); void cblas_sger(const CBLAS_LAYOUT Layout, const int M, const int N, const float alpha, const float *X, const int incX, const float *Y, const int incY, float *A, const int lda); void cblas_ssyr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, float *A, const int lda); void cblas_sspr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, float *Ap); void cblas_ssyr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, const float *Y, const int incY, float *A, const int lda); void cblas_sspr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const float *X, const int incX, const float *Y, const int incY, float *A); void cblas_dsymv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dsbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const double alpha, const double *A, const int lda, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dspmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *Ap, const double *X, const int incX, const double beta, double *Y, const int incY); void cblas_dger(const CBLAS_LAYOUT Layout, const int M, const int N, const double alpha, const double *X, const int incX, const double *Y, const int incY, double *A, const int lda); void cblas_dsyr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, double *A, const int lda); void cblas_dspr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, double *Ap); void cblas_dsyr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, const double *Y, const int incY, double *A, const int lda); void cblas_dspr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const double *X, const int incX, const double *Y, const int incY, double *A); void cblas_chemv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_chbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_chpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *Ap, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_cgeru(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_cgerc(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_cher(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const void *X, const int incX, void *A, const int lda); void cblas_chpr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const float alpha, const void *X, const int incX, void *A); void cblas_cher2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_chpr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *Ap); void cblas_zhemv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zhbmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const int K, const void *alpha, const void *A, const int lda, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zhpmv(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *Ap, const void *X, const int incX, const void *beta, void *Y, const int incY); void cblas_zgeru(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_zgerc(const CBLAS_LAYOUT Layout, const int M, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_zher(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const void *X, const int incX, void *A, const int lda); void cblas_zhpr(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const double alpha, const void *X, const int incX, void *A); void cblas_zher2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *A, const int lda); void cblas_zhpr2(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const int N, const void *alpha, const void *X, const int incX, const void *Y, const int incY, void *Ap); void cblas_sgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_sgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const float *alpha_Array, const float **A_Array, const int *lda_Array, const float **B_Array, const int *ldb_Array, const float *beta_Array, float **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_sgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_ssymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_ssyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const float alpha, const float *A, const int lda, const float beta, float *C, const int ldc); void cblas_ssyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const float alpha, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_strmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const float alpha, const float *A, const int lda, float *B, const int ldb); void cblas_strsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const float alpha, const float *A, const int lda, float *B, const int ldb); void cblas_strsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const float *alpha_Array, const float **A_Array, const int *lda_Array, float **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_dgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const double *alpha_Array, const double **A_Array, const int *lda_Array, const double **B_Array, const int* ldb_Array, const double *beta_Array, double **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_dgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dsymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dsyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const double alpha, const double *A, const int lda, const double beta, double *C, const int ldc); void cblas_dsyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const double alpha, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dtrmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const double alpha, const double *A, const int lda, double *B, const int ldb); void cblas_dtrsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const double alpha, const double *A, const int lda, double *B, const int ldb); void cblas_dtrsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *Transa_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const double *alpha_Array, const double **A_Array, const int *lda_Array, double **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_cgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_cgemm3m(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_cgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_cgemm3m_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_cgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_csymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_csyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *beta, void *C, const int ldc); void cblas_csyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_ctrmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ctrsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ctrsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *Transa_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, void **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_zgemm(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zgemm3m(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int M, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zgemm_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_zgemm3m_batch(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE *TransA_Array, const CBLAS_TRANSPOSE *TransB_Array, const int *M_Array, const int *N_Array, const int *K_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, const void **B_Array, const int* ldb_Array, const void *beta_Array, void **C_Array, const int *ldc_Array, const int group_count, const int *group_size); void cblas_zgemmt(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zsymm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zsyrk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *beta, void *C, const int ldc); void cblas_zsyr2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_ztrmm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ztrsm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE TransA, const CBLAS_DIAG Diag, const int M, const int N, const void *alpha, const void *A, const int lda, void *B, const int ldb); void cblas_ztrsm_batch(const CBLAS_LAYOUT Layout, const CBLAS_SIDE *Side_Array, const CBLAS_UPLO *Uplo_Array, const CBLAS_TRANSPOSE *Transa_Array, const CBLAS_DIAG *Diag_Array, const int *M_Array, const int *N_Array, const void *alpha_Array, const void **A_Array, const int *lda_Array, void **B_Array, const int *ldb_Array, const int group_count, const int *group_size); void cblas_chemm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_cherk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const float alpha, const void *A, const int lda, const float beta, void *C, const int ldc); void cblas_cher2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const float beta, void *C, const int ldc); void cblas_zhemm(const CBLAS_LAYOUT Layout, const CBLAS_SIDE Side, const CBLAS_UPLO Uplo, const int M, const int N, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const void *beta, void *C, const int ldc); void cblas_zherk(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const double alpha, const void *A, const int lda, const double beta, void *C, const int ldc); void cblas_zher2k(const CBLAS_LAYOUT Layout, const CBLAS_UPLO Uplo, const CBLAS_TRANSPOSE Trans, const int N, const int K, const void *alpha, const void *A, const int lda, const void *B, const int ldb, const double beta, void *C, const int ldc); __declspec(dllexport) float* cblas_sgemm_alloc(const CBLAS_IDENTIFIER identifier, const int M, const int N, const int K); void cblas_sgemm_pack(const CBLAS_LAYOUT Layout, const CBLAS_IDENTIFIER identifier, const CBLAS_TRANSPOSE Trans, const int M, const int N, const int K, const float alpha, const float *src, const int ld, float *dest); void cblas_sgemm_compute(const CBLAS_LAYOUT Layout, const int TransA, const int TransB, const int M, const int N, const int K, const float *A, const int lda, const float *B, const int ldb, const float beta, float *C, const int ldc); void cblas_sgemm_free(float *dest); __declspec(dllexport) double* cblas_dgemm_alloc(const CBLAS_IDENTIFIER identifier, const int M, const int N, const int K); void cblas_dgemm_pack(const CBLAS_LAYOUT Layout, const CBLAS_IDENTIFIER identifier, const CBLAS_TRANSPOSE Trans, const int M, const int N, const int K, const double alpha, const double *src, const int ld, double *dest); void cblas_dgemm_compute(const CBLAS_LAYOUT Layout, const int TransA, const int TransB, const int M, const int N, const int K, const double *A, const int lda, const double *B, const int ldb, const double beta, double *C, const int ldc); void cblas_dgemm_free(double *dest); void cblas_gemm_s16s16s32(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const CBLAS_OFFSET OffsetC, const int M, const int N, const int K, const float alpha, const short *A, const int lda, const short ao, const short *B, const int ldb, const short bo, const float beta, int *C, const int ldc, const int *cb); void cblas_gemm_s8u8s32(const CBLAS_LAYOUT Layout, const CBLAS_TRANSPOSE TransA, const CBLAS_TRANSPOSE TransB, const CBLAS_OFFSET OffsetC, const int M, const int N, const int K, const float alpha, const void *A, const int lda, const char ao, const void *B, const int ldb, const char bo, const float beta, int *C, const int ldc, const int *cb); #line 42 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" #line 35 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" __declspec(deprecated) void mkl_scsrmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scsrsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scscmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scscsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scoomv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scoosv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_sdiamv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sdiasv (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiagemv(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiasymv(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sskymv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sskysv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void mkl_sbsrmv (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sbsrsv(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scsrsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scscmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scscsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scoomm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scoosm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiamm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiasm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskysm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskymm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrsm(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSRSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSCMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSCSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCOOMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCOOSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SDIAMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SDIASV (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIAGEMV(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIASYMV(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SSKYMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SSKYSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void MKL_SBSRMV (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SBSRSV(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIAMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIASM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYSM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRSM(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_dcsrmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcsrsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcscmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcscsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcoomv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcoosv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_ddiamv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_ddiasv (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiagemv(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiasymv(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_dskymv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dskysv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void mkl_dbsrmv (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dbsrsv(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcsrsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoomm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoosm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiamm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiasm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskysm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskymm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrsm(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSRSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSCMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSCSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCOOMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCOOSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DDIAMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DDIASV (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIAGEMV(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIASYMV(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DSKYMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DSKYSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void MKL_DBSRMV (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DBSRSV(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIAMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIASM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYSM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRSM(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ccsrmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoomv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiamv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasv (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiagemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskymv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskysv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccsrsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoosm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiasm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskysm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASV (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIASM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoomv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiamv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasv (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiagemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskymv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskysv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoosm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiasm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskysm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASV (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIASM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_dcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_dcsrcoo(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_ddnscsr(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_dcsrcsc(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_dcsrdia(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_dcsrsky(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_scsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_scsrcoo(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_sdnscsr(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_scsrcsc(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_scsrdia(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_scsrsky(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_ccsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_ccsrcoo(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_cdnscsr(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_ccsrcsc(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_ccsrdia(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_ccsrsky(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_zcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_zcsrcoo(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_zdnscsr(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_zcsrcsc(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_zcsrdia(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_zcsrsky(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_DCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_DCSRCOO(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_DDNSCSR(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_DCSRCSC(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_DCSRDIA(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_DCSRSKY(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_SCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_SCSRCOO(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_SDNSCSR(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_SCSRCSC(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_SCSRDIA(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_SCSRSKY(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_CCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_CCSRCOO(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_CDNSCSR(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_CCSRCSC(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_CCSRDIA(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_CCSRSKY(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_ZCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_ZCSRCOO(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_ZDNSCSR(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_ZCSRCSC(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_ZCSRDIA(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_ZCSRSKY(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_dcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_dcsrmultd(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void mkl_dcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultd(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void mkl_scsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void mkl_ccsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void mkl_zcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTD(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void MKL_DCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTD(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void MKL_SCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void MKL_CCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void MKL_ZCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); typedef enum { SPARSE_STATUS_SUCCESS = 0, SPARSE_STATUS_NOT_INITIALIZED = 1, SPARSE_STATUS_ALLOC_FAILED = 2, SPARSE_STATUS_INVALID_VALUE = 3, SPARSE_STATUS_EXECUTION_FAILED = 4, SPARSE_STATUS_INTERNAL_ERROR = 5, SPARSE_STATUS_NOT_SUPPORTED = 6 } sparse_status_t; typedef enum { SPARSE_OPERATION_NON_TRANSPOSE = 10, SPARSE_OPERATION_TRANSPOSE = 11, SPARSE_OPERATION_CONJUGATE_TRANSPOSE = 12 } sparse_operation_t; typedef enum { SPARSE_MATRIX_TYPE_GENERAL = 20, SPARSE_MATRIX_TYPE_SYMMETRIC = 21, SPARSE_MATRIX_TYPE_HERMITIAN = 22, SPARSE_MATRIX_TYPE_TRIANGULAR = 23, SPARSE_MATRIX_TYPE_DIAGONAL = 24, SPARSE_MATRIX_TYPE_BLOCK_TRIANGULAR = 25, SPARSE_MATRIX_TYPE_BLOCK_DIAGONAL = 26 } sparse_matrix_type_t; typedef enum { SPARSE_INDEX_BASE_ZERO = 0, SPARSE_INDEX_BASE_ONE = 1 } sparse_index_base_t; typedef enum { SPARSE_FILL_MODE_LOWER = 40, SPARSE_FILL_MODE_UPPER = 41, SPARSE_FILL_MODE_FULL = 42 } sparse_fill_mode_t; typedef enum { SPARSE_DIAG_NON_UNIT = 50, SPARSE_DIAG_UNIT = 51 } sparse_diag_type_t; typedef enum { SPARSE_LAYOUT_ROW_MAJOR = 101, SPARSE_LAYOUT_COLUMN_MAJOR = 102 } sparse_layout_t; typedef enum { SPARSE_VERBOSE_OFF = 70, SPARSE_VERBOSE_BASIC = 71, SPARSE_VERBOSE_EXTENDED = 72 } verbose_mode_t; typedef enum { SPARSE_MEMORY_NONE = 80, SPARSE_MEMORY_AGGRESSIVE = 81 } sparse_memory_usage_t; typedef enum { SPARSE_STAGE_FULL_MULT = 90, SPARSE_STAGE_NNZ_COUNT = 91, SPARSE_STAGE_FINALIZE_MULT = 92, SPARSE_STAGE_FULL_MULT_NO_VAL = 93, SPARSE_STAGE_FINALIZE_MULT_NO_VAL = 94 } sparse_request_t; struct sparse_matrix; typedef struct sparse_matrix *sparse_matrix_t; struct matrix_descr { sparse_matrix_type_t type; sparse_fill_mode_t mode; sparse_diag_type_t diag; }; sparse_status_t mkl_sparse_s_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_copy( const sparse_matrix_t source, struct matrix_descr descr, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_destroy( sparse_matrix_t A ); sparse_status_t mkl_sparse_get_error_info( sparse_matrix_t A, int *info ); sparse_status_t mkl_sparse_convert_csr ( const sparse_matrix_t source, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_convert_bsr ( const sparse_matrix_t source, int block_size, sparse_layout_t block_layout, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_s_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_set_value( sparse_matrix_t A, int row, int col, float value ); sparse_status_t mkl_sparse_d_set_value( sparse_matrix_t A, int row, int col, double value ); sparse_status_t mkl_sparse_c_set_value( sparse_matrix_t A, int row, int col, MKL_Complex8 value ); sparse_status_t mkl_sparse_z_set_value( sparse_matrix_t A, int row, int col, MKL_Complex16 value ); sparse_status_t mkl_sparse_set_verbose_mode ( verbose_mode_t verbose ); sparse_status_t mkl_sparse_set_mv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_mm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_sv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_sm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_memory_hint ( sparse_matrix_t A, sparse_memory_usage_t policy ); sparse_status_t mkl_sparse_optimize ( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_mv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y ); sparse_status_t mkl_sparse_d_mv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y ); sparse_status_t mkl_sparse_c_mv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_mv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_trsv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float *y ); sparse_status_t mkl_sparse_d_trsv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double *y ); sparse_status_t mkl_sparse_c_trsv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_trsv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_mm( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float beta, float *y, int ldy ); sparse_status_t mkl_sparse_d_mm( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double beta, double *y, int ldy ); sparse_status_t mkl_sparse_c_mm( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 beta, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_mm( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 beta, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_trsm ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float *y, int ldy ); sparse_status_t mkl_sparse_d_trsm ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double *y, int ldy ); sparse_status_t mkl_sparse_c_trsm ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_trsm ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_add( sparse_operation_t operation, const sparse_matrix_t A, float alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_d_add( sparse_operation_t operation, const sparse_matrix_t A, double alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_c_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_z_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_spmm( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sp2m ( sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, sparse_request_t request, sparse_matrix_t *C ); sparse_status_t mkl_sparse_syrk ( sparse_operation_t operation, const sparse_matrix_t A, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sypr ( sparse_operation_t transA, const sparse_matrix_t A, const sparse_matrix_t B, struct matrix_descr descrB, sparse_matrix_t *C, sparse_request_t request ); sparse_status_t mkl_sparse_s_syprd ( const sparse_operation_t op, const sparse_matrix_t A, float *B, const sparse_layout_t layoutB, const int ldb, float alpha, float beta, float *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_d_syprd ( const sparse_operation_t op, const sparse_matrix_t A, double *B, const sparse_layout_t layoutB, const int ldb, double alpha, double beta, double *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_c_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex8 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_z_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex16 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_order( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, float *C, int ldc ); sparse_status_t mkl_sparse_d_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, double *C, int ldc ); sparse_status_t mkl_sparse_c_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex8 *C, int ldc ); sparse_status_t mkl_sparse_z_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex16 *C, int ldc ); sparse_status_t mkl_sparse_d_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const double alpha, const double beta, double *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_s_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const float alpha, const float beta, float *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_z_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex16 alpha, const MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_c_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex8 alpha, const MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_set_symgs_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_d_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x, double *y); sparse_status_t mkl_sparse_d_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x); sparse_status_t mkl_sparse_set_dotmv_hint( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expectedCalls ); sparse_status_t mkl_sparse_d_dotmv( sparse_operation_t transA, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y, double *d ); sparse_status_t mkl_sparse_s_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x, float *y); sparse_status_t mkl_sparse_s_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x); sparse_status_t mkl_sparse_s_dotmv( sparse_operation_t transA, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y, float *d ); sparse_status_t mkl_sparse_c_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x, MKL_Complex8 *y); sparse_status_t mkl_sparse_c_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x); sparse_status_t mkl_sparse_c_dotmv( sparse_operation_t transA, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y, MKL_Complex8 *d ); sparse_status_t mkl_sparse_z_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x, MKL_Complex16 *y); sparse_status_t mkl_sparse_z_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x); sparse_status_t mkl_sparse_z_dotmv( sparse_operation_t transA, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y, MKL_Complex16 *d ); sparse_status_t mkl_sparse_s_syrkd( sparse_operation_t operation, const sparse_matrix_t A, float alpha, float beta, float *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_d_syrkd( sparse_operation_t operation, const sparse_matrix_t A, double alpha, double beta, double *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_c_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_z_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, sparse_layout_t layout, int ldc ); #line 43 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_lapack.h" typedef int (*MKL_C_SELECT_FUNCTION_1) ( const MKL_Complex8* ); typedef int (*MKL_C_SELECT_FUNCTION_2) ( const MKL_Complex8*, const MKL_Complex8* ); typedef int (*MKL_D_SELECT_FUNCTION_2) ( const double*, const double* ); typedef int (*MKL_D_SELECT_FUNCTION_3) ( const double*, const double*, const double* ); typedef int (*MKL_S_SELECT_FUNCTION_2) ( const float*, const float* ); typedef int (*MKL_S_SELECT_FUNCTION_3) ( const float*, const float*, const float* ); typedef int (*MKL_Z_SELECT_FUNCTION_1) ( const MKL_Complex16* ); typedef int (*MKL_Z_SELECT_FUNCTION_2) ( const MKL_Complex16*, const MKL_Complex16* ); void CGELQ( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGELQ_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgelq( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgelq_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGELQT( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CGELQT_( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgelqt( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgelqt_( const int* m, const int* n, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CGELQT3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGELQT3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgelqt3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgelqt3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CGEQR( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGEQR_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgeqr( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void cgeqr_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* tsize, MKL_Complex8* work, const int* lwork, int* info ); void CGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgetsls( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void clamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CLASWLQ( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void claswlq( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void claswlq_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CLATSQR( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CLATSQR_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void clatsqr( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void clatsqr_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, const int* lwork, int* info ); void CTPLQT( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CTPLQT_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctplqt( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctplqt_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CTPLQT2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void CTPLQT2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctplqt2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctplqt2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void CTPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CTPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void DGELQ( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DGELQ_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgelq( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgelq_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DGELQT( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void DGELQT_( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgelqt( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgelqt_( const int* m, const int* n, const int* mb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void DGELQT3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGELQT3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgelqt3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgelqt3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void DGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void DGEQR( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DGEQR_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgeqr( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void dgeqr_( const int* m, const int* n, double* a, const int* lda, double* t, const int* tsize, double* work, const int* lwork, int* info ); void DLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dlamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, double* a, const int* lda, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DLASWLQ( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlaswlq( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlaswlq_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DLATSQR( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DLATSQR_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlatsqr( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void dlatsqr_( const int* m, const int* n, const int* mb, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, const int* lwork, int* info ); void DTPLQT( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void DTPLQT_( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtplqt( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtplqt_( const int* m, const int* n, const int* l, const int* mb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void DTPLQT2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void DTPLQT2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtplqt2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtplqt2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void DTPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void DTPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void SGELQ( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void SGELQ_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgelq( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgelq_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void DGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgetsls( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void SGELQT( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void SGELQT_( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgelqt( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgelqt_( const int* m, const int* n, const int* mb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void SGELQT3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGELQT3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgelqt3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgelqt3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void SGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void SGEQR( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void SGEQR_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgeqr( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void sgeqr_( const int* m, const int* n, float* a, const int* lda, float* t, const int* tsize, float* work, const int* lwork, int* info ); void SGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgetsls( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLASWLQ( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void SLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slaswlq( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slaswlq_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void STPLQT( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void STPLQT_( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stplqt( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stplqt_( const int* m, const int* n, const int* l, const int* mb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void STPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void STPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void ZGELQ( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void ZGELQ_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgelq( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgelq_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void SGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void slamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, float* a, const int* lda, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SLATSQR( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void SLATSQR_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slatsqr( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void slatsqr_( const int* m, const int* n, const int* mb, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, const int* lwork, int* info ); void STPLQT2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void STPLQT2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stplqt2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stplqt2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void ZGELQT( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZGELQT_( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgelqt( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgelqt_( const int* m, const int* n, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZGELQT3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGELQT3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgelqt3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgelqt3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGEMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZGEMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZGEMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZGEMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZGEQR( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQR_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgeqr( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void zgeqr_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* tsize, MKL_Complex16* work, const int* lwork, int* info ); void ZGETSLS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZGETSLS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgetsls( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgetsls_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMSWLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMSWLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamswlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamswlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMTSQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLAMTSQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamtsqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zlamtsqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZLASWLQ( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZLASWLQ_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlaswlq( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlaswlq_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZLATSQR( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZLATSQR_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlatsqr( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void zlatsqr_( const int* m, const int* n, const int* mb, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, const int* lwork, int* info ); void ZTPLQT( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZTPLQT_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztplqt( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztplqt_( const int* m, const int* n, const int* l, const int* mb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZTPLQT2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ZTPLQT2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztplqt2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztplqt2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ZTPMLQT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZTPMLQT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmlqt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmlqt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* mb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void CHESV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_AA( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_AA_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_aa( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_aa_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void CHETRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void chetrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void chetrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void CLAHEF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void CLAHEF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clahef_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clahef_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void DLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void DLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void dlasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void dlasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, double* a, const int* lda, int* ipiv, double* h, const int* ldh, double* work, int* info ); void DSYSV_AA( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_AA_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_aa( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_aa_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYTRF_AA( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_AA_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_aa( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_aa_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void DSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void dsytrs_aa( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void dsytrs_aa_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, const double* work, const int* lwork, int* info ); void SLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void SLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void slasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void slasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, float* a, const int* lda, int* ipiv, float* h, const int* ldh, float* work, int* info ); void SSYSV_AA( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_AA_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_aa( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_aa_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYTRF_AA( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_AA_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_aa( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_aa_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void SSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void ssytrs_aa( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void ssytrs_aa_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, const float* work, const int* lwork, int* info ); void ZHESV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_AA( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_AA_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_aa( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_aa_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void ZHETRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zhetrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zhetrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void ZLAHEF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void ZLAHEF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlahef_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlahef_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void CGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* t, const int* tsize, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void DGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* t, const int* tsize, double* c, const int* ldc, double* work, const int* lwork, int* info ); void SGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* t, const int* tsize, float* c, const int* ldc, float* work, const int* lwork, int* info ); void ZGEMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZGEMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zgemqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* t, const int* tsize, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void CHECON_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHECON_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHESV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHETF2_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CHETF2_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void chetf2_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void chetf2_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CHETRF_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_3X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CHETRI_3X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri_3x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri_3x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CHETRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHETRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CLAHEF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHEF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLARFY( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARFY_( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfy( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfy_( const char* uplo, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void CLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void clasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* h, const int* ldh, MKL_Complex8* work, int* info ); void CLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CSYCON_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCON_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_3( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_3_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCONVF( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYCONVF_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csyconvf( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csyconvf_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYCONVF_ROOK( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void CSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void csyconvf_rook( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void csyconvf_rook_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, const int* ipiv, int* info ); void CSYSV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYTF2_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYTF2_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csytf2_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void csytf2_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, int* info ); void CSYTRF_AA( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_AA_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_aa( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_aa_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_RK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_RK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rk( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rk_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri_3( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri_3_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_3X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CSYTRI_3X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void csytri_3x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void csytri_3x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CSYTRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void CSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void csytrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void csytrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, const MKL_Complex8* work, const int* lwork, int* info ); void DLARFY( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARFY_( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarfy( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarfy_( const char* uplo, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void DLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, double* e, int* ipiv, double* w, const int* ldw, int* info ); void DSYCON_3( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCON_3_( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_3( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_3_( const char* uplo, const int* n, const double* a, const int* lda, const double* e, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCONVF( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYCONVF_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsyconvf( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsyconvf_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYCONVF_ROOK( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void DSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void dsyconvf_rook( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void dsyconvf_rook_( const char* uplo, const char* way, const int* n, double* a, const int* lda, double* e, const int* ipiv, int* info ); void DSYSV_RK( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_RK_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rk( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rk_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* e, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYTF2_RK( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYTF2_RK_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsytf2_rk( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void dsytf2_rk_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, int* info ); void DSYTRF_RK( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_RK_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rk( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rk_( const char* uplo, const int* n, double* a, const int* lda, double* e, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_3( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_3_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri_3( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri_3_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_3X( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void DSYTRI_3X_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void dsytri_3x( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void dsytri_3x_( const char* uplo, const int* n, double* a, const int* lda, const double* e, const int* ipiv, double* work, const int* nb, int* info ); void DSYTRS_3( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void DSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_3( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_3_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* e, const int* ipiv, double* b, const int* ldb, int* info ); void SLARFY( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARFY_( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarfy( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarfy_( const char* uplo, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void SLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, float* e, int* ipiv, float* w, const int* ldw, int* info ); void SSYCON_3( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCON_3_( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_3( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_3_( const char* uplo, const int* n, const float* a, const int* lda, const float* e, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCONVF( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYCONVF_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssyconvf( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssyconvf_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYCONVF_ROOK( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void SSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void ssyconvf_rook( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void ssyconvf_rook_( const char* uplo, const char* way, const int* n, float* a, const int* lda, float* e, const int* ipiv, int* info ); void SSYSV_RK( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_RK_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rk( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rk_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* e, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYTF2_RK( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYTF2_RK_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssytf2_rk( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void ssytf2_rk_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, int* info ); void SSYTRF_RK( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_RK_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rk( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rk_( const char* uplo, const int* n, float* a, const int* lda, float* e, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_3( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_3_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri_3( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri_3_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_3X( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void SSYTRI_3X_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void ssytri_3x( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void ssytri_3x_( const char* uplo, const int* n, float* a, const int* lda, const float* e, const int* ipiv, float* work, const int* nb, int* info ); void SSYTRS_3( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void SSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_3( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_3_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* e, const int* ipiv, float* b, const int* ldb, int* info ); void ZHECON_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHECON_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHESV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHETF2_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZHETF2_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zhetf2_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zhetf2_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZHETRF_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_3X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZHETRI_3X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri_3x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri_3x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZHETRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHETRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZLAHEF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHEF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLARFY( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARFY_( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfy( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfy_( const char* uplo, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLASYF_AA( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void ZLASYF_AA_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlasyf_aa( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void zlasyf_aa_( const char* uplo, const int* j1, const int* m, const int* nb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* h, const int* ldh, MKL_Complex16* work, int* info ); void ZLASYF_RK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_RK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rk( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rk_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZSYCON_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCON_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_3( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_3_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCONVF( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYCONVF_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsyconvf( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsyconvf_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYCONVF_ROOK( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void ZSYCONVF_ROOK_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void zsyconvf_rook( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void zsyconvf_rook_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, const int* ipiv, int* info ); void ZSYSV_AA( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_AA_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_aa( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_aa_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_RK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_RK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rk( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rk_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTF2_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYTF2_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsytf2_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void zsytf2_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, int* info ); void ZSYTRF_AA( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_AA_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_aa( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_aa_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_RK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_RK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rk( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rk_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri_3( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri_3_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_3X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZSYTRI_3X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zsytri_3x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zsytri_3x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZSYTRS_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_3( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_3_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_AA( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRS_AA_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zsytrs_aa( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void zsytrs_aa_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, const MKL_Complex16* work, const int* lwork, int* info ); void CHB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void CHB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void chb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void chb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex8* a, const int* lda, MKL_Complex8* v, MKL_Complex8* tau, const int* ldvt, const MKL_Complex8* work ); void CHBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEEV_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEV_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEVD_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHETRD_2STAGE( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_2STAGE_( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_2stage( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_2stage_( const char* vect, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* hous2, const int* lhous2, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_hb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_hb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* hous, const int* lhous, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HE2HB( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_HE2HB_( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_he2hb( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_he2hb_( const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, MKL_Complex8* ab, const int* ldab, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void DSB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void DSB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void dsb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void dsb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, double* a, const int* lda, double* v, double* tau, const int* ldvt, const double* work ); void DSBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DSBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DSBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYEV_2STAGE( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEV_2STAGE_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev_2stage( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev_2stage_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEVD_2STAGE( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd_2stage( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd_2stage_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYTRD_2STAGE( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void DSYTRD_2STAGE_( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void dsytrd_2stage( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void dsytrd_2stage_( const char* vect, const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* hous2, const int* lhous2, double* work, const int* lwork, int* info ); void DSYTRD_SB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void DSYTRD_SB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void dsytrd_sb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void dsytrd_sb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* hous, const int* lhous, double* work, const int* lwork, int* info ); void DSYTRD_SY2SB( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); void DSYTRD_SY2SB_( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); void dsytrd_sy2sb( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); void dsytrd_sy2sb_( const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* ab, const int* ldab, double* tau, double* work, const int* lwork, int* info ); int IPARAM2STAGE( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); int IPARAM2STAGE_( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); int iparam2stage( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); int iparam2stage_( const int* ispec, const char* name, const char* opts, const int* ni, const int* nbi, const int* ibi, const int* nxi ); void SSB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void SSB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void ssb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void ssb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, float* a, const int* lda, float* v, float* tau, const int* ldvt, const float* work ); void SSBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SSBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SSBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYEV_2STAGE( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEV_2STAGE_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev_2stage( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev_2stage_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEVD_2STAGE( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd_2stage( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd_2stage_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYTRD_2STAGE( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void SSYTRD_2STAGE_( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void ssytrd_2stage( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void ssytrd_2stage_( const char* vect, const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* hous2, const int* lhous2, float* work, const int* lwork, int* info ); void SSYTRD_SB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void SSYTRD_SB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void ssytrd_sb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void ssytrd_sb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* hous, const int* lhous, float* work, const int* lwork, int* info ); void SSYTRD_SY2SB( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void SSYTRD_SY2SB_( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void ssytrd_sy2sb( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void ssytrd_sy2sb_( const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* ab, const int* ldab, float* tau, float* work, const int* lwork, int* info ); void ZHB2ST_KERNELS( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void ZHB2ST_KERNELS_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void zhb2st_kernels( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void zhb2st_kernels_( const char* uplo, const int* wantz, const int* ttype, const int* st, const int* ed, const int* sweep, const int* n, const int* nb, const int* ib, MKL_Complex16* a, const int* lda, MKL_Complex16* v, MKL_Complex16* tau, const int* ldvt, const MKL_Complex16* work ); void ZHBEV_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHBEV_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhbev_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhbev_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHBEVD_2STAGE( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd_2stage( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd_2stage_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHBEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEEV_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEV_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEVD_2STAGE( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVD_2STAGE_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd_2stage( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd_2stage_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVR_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVR_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVX_2STAGE( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEEVX_2STAGE_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx_2stage( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx_2stage_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEGV_2STAGE( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEGV_2STAGE_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv_2stage( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv_2stage_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHETRD_2STAGE( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_2STAGE_( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_2stage( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_2stage_( const char* vect, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* hous2, const int* lhous2, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HB2ST( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HB2ST_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_hb2st( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_hb2st_( const char* stage1, const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* hous, const int* lhous, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HE2HB( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_HE2HB_( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_he2hb( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_he2hb_( const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, MKL_Complex16* ab, const int* ldab, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void MKL_CGETRFNP( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void MKL_CGETRFNP_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnp( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnp_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void MKL_DGETRFNP( const int* m, const int* n, double* a, const int* lda, int* info ); void MKL_DGETRFNP_( const int* m, const int* n, double* a, const int* lda, int* info ); void mkl_dgetrfnp( const int* m, const int* n, double* a, const int* lda, int* info ); void mkl_dgetrfnp_( const int* m, const int* n, double* a, const int* lda, int* info ); void MKL_SGETRFNP( const int* m, const int* n, float* a, const int* lda, int* info ); void MKL_SGETRFNP_( const int* m, const int* n, float* a, const int* lda, int* info ); void mkl_sgetrfnp( const int* m, const int* n, float* a, const int* lda, int* info ); void mkl_sgetrfnp_( const int* m, const int* n, float* a, const int* lda, int* info ); void MKL_ZGETRFNP( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void MKL_ZGETRFNP_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnp( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnp_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void MKL_CGETRINP( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void MKL_CGETRINP_( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void mkl_cgetrinp( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void mkl_cgetrinp_( const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* work, const int* lwork, int* info ); void MKL_DGETRINP( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void MKL_DGETRINP_( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void mkl_dgetrinp( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void mkl_dgetrinp_( const int* n, double* a, const int* lda, double* work, const int* lwork, int* info ); void MKL_SGETRINP( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void MKL_SGETRINP_( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void mkl_sgetrinp( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void mkl_sgetrinp_( const int* n, float* a, const int* lda, float* work, const int* lwork, int* info ); void MKL_ZGETRINP( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void MKL_ZGETRINP_( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void mkl_zgetrinp( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void mkl_zgetrinp_( const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* work, const int* lwork, int* info ); void CGEJSV( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void CGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void ZGEJSV( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void ZGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void DGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void DGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void SGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void SGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void CGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void CGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void cgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void cgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work,const int* lwork, float* rwork, int* iwork, int* info ); void ZGESVDX( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void ZGESVDX_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void zgesvdx( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void zgesvdx_( const char* jobu, const char* jobvt, const char* range, const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work,const int* lwork, double* rwork, int* iwork, int* info ); void CGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void CGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void cgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void cgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, MKL_Complex8* cwork, const int* lwork, float* rwork, const int* lrwork, int* info ); void ZGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void ZGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void zgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void zgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, MKL_Complex16* cwork, const int* lwork, double* rwork, const int* lrwork, int* info ); void DGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void DGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void dggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void dggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, const int* lwork, int* iwork, int* info ); void SGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void SGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void sggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void sggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, const int* lwork, int* iwork, int* info ); void CGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void ZGGSVD3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGGSVD3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zggsvd3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zggsvd3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void DGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void DGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void dggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void dggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, const int* lwork, int* info ); void SGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void SGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void sggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void sggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, const int* lwork, int* info ); void CGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void ZGGSVP3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGGSVP3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zggsvp3( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zggsvp3_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void CGSVJ0( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void CGSVJ0_( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj0( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj0_( const char* jobv, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void ZGSVJ0( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void ZGSVJ0_( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj0( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj0_( const char* jobv, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void CGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void CGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void cgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex8* a, const int* lda, MKL_Complex8* d, float* sva, const int* mv, MKL_Complex8* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, MKL_Complex8* work, const int* lwork, int* info ); void ZGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void ZGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj1( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void zgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, MKL_Complex16* a, const int* lda, MKL_Complex16* d, double* sva, const int* mv, MKL_Complex16* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, MKL_Complex16* work, const int* lwork, int* info ); void CPOTRF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void DPOTRF2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRF2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void SPOTRF2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRF2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void ZPOTRF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void DBDSVDX( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void DBDSVDX_( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void dbdsvdx( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void dbdsvdx_( const char* uplo, const char* jobz, const char* range, const int* n, const double* d, const double* e, const double* vl, const double* vu, const int* il, const int* iu, int* ns, double* s, double* z, const int* ldz, double* work, int* iwork, int* info ); void SBDSVDX( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void SBDSVDX_( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void sbdsvdx( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void sbdsvdx_( const char* uplo, const char* jobz, const char* range, const int* n, const float* d, const float* e, const float* vl, const float* vu, const int* il, const int* iu, int* ns, float* s, float* z, const int* ldz, float* work, int* iwork, int* info ); void CGETRF2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETRF2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void DGETRF2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETRF2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void SGETRF2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETRF2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ZGETRF2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETRF2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void CGGEV3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGGEV3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void ZGGEV3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGGEV3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev3( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev3_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void DGGEV3( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGGEV3_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev3( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev3_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void SGGEV3( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGGEV3_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev3( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev3_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void CUNM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex8* q, const int* ldq, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void ZUNM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const MKL_Complex16* q, const int* ldq, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void CGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void DGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void SGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void sgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void sgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ZGGHD3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZGGHD3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zgghd3( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zgghd3_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void CGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void ZGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void DGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void DGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void SGGES3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void SGGES3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges3( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges3_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void DORM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dorm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dorm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const double* q, const int* ldq, double* c, const int* ldc, double* work, const int* lwork, int* info ); void SORM22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORM22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sorm22( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sorm22_( const char* side, const char* trans, const int* m, const int* n, const int* n1, const int* n2, const float* q, const int* ldq, float* c, const int* ldc, float* work, const int* lwork, int* info ); void CHECON_ROOK( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHECON_ROOK_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_rook( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_rook_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHESV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHETF2_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETF2_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETRF_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRI_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHETRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CLAHEF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHEF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CSYCON_ROOK( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCON_ROOK_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_rook( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_rook_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYTF2_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTF2_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTRF_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI_ROOK( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRI_ROOK_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri_rook( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri_rook_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void DLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DSYCON_ROOK( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCON_ROOK_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_rook( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_rook_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rook( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_rook_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYTF2_ROOK( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTF2_ROOK_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2_rook( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2_rook_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTRF_ROOK( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_ROOK_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rook( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_rook_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI_ROOK( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRI_ROOK_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri_rook( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri_rook_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_rook( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_rook_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void SLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SSYCON_ROOK( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCON_ROOK_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_rook( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_rook_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rook( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_rook_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYTF2_ROOK( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTF2_ROOK_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2_rook( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2_rook_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTRF_ROOK( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_ROOK_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rook( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_rook_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI_ROOK( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRI_ROOK_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri_rook( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri_rook_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_rook( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_rook_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ZHECON_ROOK( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHECON_ROOK_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_rook( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_rook_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHESV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHETF2_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETF2_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETRF_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRI_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHETRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZLAHEF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHEF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_ROOK( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_ROOK_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rook( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_rook_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZSYCON_ROOK( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCON_ROOK_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_rook( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_rook_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYSV_ROOK( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_ROOK_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rook( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_rook_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTF2_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTF2_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTRF_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI_ROOK( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRI_ROOK_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri_rook( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri_rook_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRS_ROOK( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_ROOK_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_rook( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_rook_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void CUNBDB1( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB1_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb1( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb1_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB2( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB2_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb2( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb2_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB3( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB3_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb3( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb3_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB4( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB4_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb4( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb4_( const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* phantom, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB5( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB5_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb5( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb5_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB6( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNBDB6_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb6( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void cunbdb6_( const int* m1, const int* m2, const int* n, MKL_Complex8* x1, const int* incx1, MKL_Complex8* x2, const int* incx2, MKL_Complex8* q1, const int* ldq1, MKL_Complex8* q2, const int* ldq2, MKL_Complex8* work, const int* lwork, int* info ); void CUNCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void CUNCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cuncsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void cuncsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x21, const int* ldx21, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info ); void DORBDB1( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB1_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb1( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb1_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB2( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB2_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb2( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb2_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB3( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB3_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb3( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void dorbdb3_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* work, const int* lwork, int* info ); void DORBDB4( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void DORBDB4_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void dorbdb4( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void dorbdb4_( const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* phantom, double* work, const int* lwork, int* info ); void DORBDB5( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORBDB5_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb5( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb5_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORBDB6( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORBDB6_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb6( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void dorbdb6_( const int* m1, const int* m2, const int* n, double* x1, const int* incx1, double* x2, const int* incx2, double* q1, const int* ldq1, double* q2, const int* ldq2, double* work, const int* lwork, int* info ); void DORCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void DORCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void dorcsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void dorcsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, double* x11, const int* ldx11, double* x21, const int* ldx21, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* work, const int* lwork, int* iwork, int* info ); void SORBDB1( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB1_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb1( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb1_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB2( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB2_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb2( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb2_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB3( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB3_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb3( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void sorbdb3_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* work, const int* lwork, int* info ); void SORBDB4( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void SORBDB4_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void sorbdb4( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void sorbdb4_( const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* phantom, float* work, const int* lwork, int* info ); void SORBDB5( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORBDB5_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb5( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb5_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORBDB6( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORBDB6_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb6( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void sorbdb6_( const int* m1, const int* m2, const int* n, float* x1, const int* incx1, float* x2, const int* incx2, float* q1, const int* ldq1, float* q2, const int* ldq2, float* work, const int* lwork, int* info ); void SORCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void SORCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void sorcsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void sorcsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, float* x11, const int* ldx11, float* x21, const int* ldx21, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* work, const int* lwork, int* iwork, int* info ); void ZUNBDB1( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB1_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb1( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb1_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB2( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB2_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb2( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb2_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB3( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB3_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb3( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb3_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB4( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB4_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb4( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb4_( const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* phantom, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB5( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB5_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb5( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb5_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB6( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNBDB6_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb6( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void zunbdb6_( const int* m1, const int* m2, const int* n, MKL_Complex16* x1, const int* incx1, MKL_Complex16* x2, const int* incx2, MKL_Complex16* q1, const int* ldq1, MKL_Complex16* q2, const int* ldq2, MKL_Complex16* work, const int* lwork, int* info ); void ZUNCSD2BY1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void ZUNCSD2BY1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zuncsd2by1( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void zuncsd2by1_( const char* jobu1, const char* jobu2, const char* jobv1t, const int* m, const int* p, const int* q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x21, const int* ldx21, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info ); void CGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void DGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void DGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void dgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, int* info ); void SGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void SGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void sgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, int* info ); void ZGEMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZGEMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zgemqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void CGEQRT( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CGEQRT_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgeqrt( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void cgeqrt_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void DGEQRT( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void DGEQRT_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgeqrt( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void dgeqrt_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* t, const int* ldt, double* work, int* info ); void SGEQRT( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void SGEQRT_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgeqrt( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void sgeqrt_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* t, const int* ldt, float* work, int* info ); void ZGEQRT( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZGEQRT_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgeqrt( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void zgeqrt_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void CGEQRT3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGEQRT3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt3( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void DGEQRT3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGEQRT3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt3( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt3_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void SGEQRT3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGEQRT3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt3( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt3_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void ZGEQRT3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGEQRT3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt3( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void CTPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CTPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ctpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void DTPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void DTPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void dtpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, int* info ); void STPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void STPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void stpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, int* info ); void ZTPMQRT( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZTPMQRT_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmqrt( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ztpmqrt_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const int* nb, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void CTPQRT( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void CTPQRT_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctpqrt( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void ctpqrt_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, MKL_Complex8* work, int* info ); void DTPQRT( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void DTPQRT_( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtpqrt( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void dtpqrt_( const int* m, const int* n, const int* l, const int* nb, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, double* work, int* info ); void STPQRT( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void STPQRT_( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stpqrt( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void stpqrt_( const int* m, const int* n, const int* l, const int* nb, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, float* work, int* info ); void ZTPQRT( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ZTPQRT_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztpqrt( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void ztpqrt_( const int* m, const int* n, const int* l, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, MKL_Complex16* work, int* info ); void CTPQRT2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void CTPQRT2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctpqrt2( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void ctpqrt2_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* t, const int* ldt, int* info ); void DTPQRT2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void DTPQRT2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtpqrt2( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void dtpqrt2_( const int* m, const int* n, const int* l, double* a, const int* lda, double* b, const int* ldb, double* t, const int* ldt, int* info ); void STPQRT2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void STPQRT2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stpqrt2( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void stpqrt2_( const int* m, const int* n, const int* l, float* a, const int* lda, float* b, const int* ldb, float* t, const int* ldt, int* info ); void ZTPQRT2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ZTPQRT2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztpqrt2( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void ztpqrt2_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* t, const int* ldt, int* info ); void CBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void CBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void cbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void cbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void ZBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void ZBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void zbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void zbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void SBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void SBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void sbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void sbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, float* theta, float* phi, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, const int* lrwork, int* info ); void DBBCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void DBBCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void dbbcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void dbbcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const int* M, const int* P, const int* Q, double* theta, double* phi, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, const int* lrwork, int* info ); void CUNBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void CUNBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void cunbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void cunbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, const int* lwork, int* info); void ZUNBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void ZUNBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void zunbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void zunbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, const int* lwork, int* info); void SORBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void SORBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void sorbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void sorbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, const int* lwork, int* info); void DORBDB( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void DORBDB_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void dorbdb( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void dorbdb_( const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, const int* lwork, int* info); void CUNCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void CUNCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void cuncsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void cuncsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex8* x11, const int* ldx11, MKL_Complex8* x12, const int* ldx12, MKL_Complex8* x21, const int* ldx21, MKL_Complex8* x22, const int* ldx22, float* theta, MKL_Complex8* u1, const int* ldu1, MKL_Complex8* u2, const int* ldu2, MKL_Complex8* v1t, const int* ldv1t, MKL_Complex8* v2t, const int* ldv2t, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, int* info); void ZUNCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void ZUNCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void zuncsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void zuncsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, MKL_Complex16* x11, const int* ldx11, MKL_Complex16* x12, const int* ldx12, MKL_Complex16* x21, const int* ldx21, MKL_Complex16* x22, const int* ldx22, double* theta, MKL_Complex16* u1, const int* ldu1, MKL_Complex16* u2, const int* ldu2, MKL_Complex16* v1t, const int* ldv1t, MKL_Complex16* v2t, const int* ldv2t, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, int* info); void SORCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void SORCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void sorcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void sorcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, float* x11, const int* ldx11, float* x12, const int* ldx12, float* x21, const int* ldx21, float* x22, const int* ldx22, float* theta, float* u1, const int* ldu1, float* u2, const int* ldu2, float* v1t, const int* ldv1t, float* v2t, const int* ldv2t, float* work, const int* lwork, int* iwork, int* info); void DORCSD( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void DORCSD_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void dorcsd( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void dorcsd_( const char* jobu1, const char* jobu2, const char* jobv1t, const char* jobv2t, const char* trans, const char* signs, const int* M, const int* P, const int* Q, double* x11, const int* ldx11, double* x12, const int* ldx12, double* x21, const int* ldx21, double* x22, const int* ldx22, double* theta, double* u1, const int* ldu1, double* u2, const int* ldu2, double* v1t, const int* ldv1t, double* v2t, const int* ldv2t, double* work, const int* lwork, int* iwork, int* info); void CLAPMR( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void CLAPMR_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmr( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmr_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void DLAPMR( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void DLAPMR_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmr( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmr_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void ZLAPMR( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void ZLAPMR_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmr( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmr_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void SLAPMR( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void SLAPMR_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmr( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmr_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void CSYCONV( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void CSYCONV_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void csyconv( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void csyconv_( const char* uplo, const char* way, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* e, int* info ); void ZSYCONV( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void ZSYCONV_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void zsyconv( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void zsyconv_( const char* uplo, const char* way, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* e, int* info ); void SSYCONV( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void SSYCONV_( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void ssyconv( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void ssyconv_( const char* uplo, const char* way, const int* n, float* a, const int* lda, const int* ipiv, float* e, int* info ); void DSYCONV( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void DSYCONV_( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void dsyconv( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void dsyconv_( const char* uplo, const char* way, const int* n, double* a, const int* lda, const int* ipiv, double* e, int* info ); void CSYSWAPR( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void CSYSWAPR_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void csyswapr( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void csyswapr_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void ZSYSWAPR( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void ZSYSWAPR_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zsyswapr( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zsyswapr_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void SSYSWAPR( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void SSYSWAPR_( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void ssyswapr( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void ssyswapr_( const char* uplo, const int* n, float* a, const int* lda, const int* i1, const int* i2 ); void DSYSWAPR( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void DSYSWAPR_( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void dsyswapr( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void dsyswapr_( const char* uplo, const int* n, double* a, const int* lda, const int* i1, const int* i2 ); void CSYTRI2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytri2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void ZSYTRI2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytri2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void SSYTRI2( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI2_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri2( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void ssytri2_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void DSYTRI2( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI2_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri2( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dsytri2_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void CSYTRI2X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void CSYTRI2X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void csytri2x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void csytri2x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* nb, int* info ); void ZSYTRI2X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void ZSYTRI2X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void zsytri2x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void zsytri2x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* nb, int* info ); void SSYTRI2X( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void SSYTRI2X_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void ssytri2x( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void ssytri2x_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* nb, int* info ); void DSYTRI2X( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void DSYTRI2X_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void dsytri2x( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void dsytri2x_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* nb, int* info ); void SLARTGP( float* f, float* g, float* cs, float* sn, float* r ); void SLARTGP_( float* f, float* g, float* cs, float* sn, float* r ); void slartgp( float* f, float* g, float* cs, float* sn, float* r ); void slartgp_( float* f, float* g, float* cs, float* sn, float* r ); void DLARTGP( double* f, double* g, double* cs, double* sn, double* r ); void DLARTGP_( double* f, double* g, double* cs, double* sn, double* r ); void dlartgp( double* f, double* g, double* cs, double* sn, double* r ); void dlartgp_( double* f, double* g, double* cs, double* sn, double* r ); void SLARTGS( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void SLARTGS_( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void slartgs( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void slartgs_( const float* x, const float* y, const float* sigma, float* cs, float* sn ); void DLARTGS( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void DLARTGS_( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void dlartgs( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void dlartgs_( const double* x, const double* y, const double* sigma, double* cs, double* sn ); void CSYTRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CSYTRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void csytrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void csytrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ZSYTRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZSYTRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zsytrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zsytrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void SSYTRS2( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void SSYTRS2_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void ssytrs2( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void ssytrs2_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, float* work, int* info ); void DSYTRS2( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void DSYTRS2_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void dsytrs2( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void dsytrs2_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, double* work, int* info ); void CHETRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void CHETRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void chetrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void chetrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, int* info ); void ZHETRS2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void ZHETRS2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zhetrs2( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void zhetrs2_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, int* info ); void CBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void CBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void cbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void cbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* u, const int* ldu, MKL_Complex8* c, const int* ldc, float* rwork, int* info ); void CGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void CGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void cgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void cgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* pt, const int* ldpt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, float* rwork, int* info ); void CGBCON( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgbcon( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequb( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequb_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBEQU( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequ( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgbequ_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGBTF2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTF2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtf2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtf2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTRF( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTRF_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtrf( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void cgbtrf_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, int* ipiv, int* info ); void CGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGEBAL( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void CGEBAL_( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void cgebal( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void cgebal_( const char* job, const int* n, MKL_Complex8* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void CGEBD2( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void CGEBD2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void cgebd2( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void cgebd2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int* info ); void CGEBRD( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void CGEBRD_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void cgebrd( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void cgebrd_( const int* m, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, const int* lwork, int* info ); void CGECON( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGECON_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgecon( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cgecon_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CGEEQUB( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEEQUB_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequb( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequb_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEEQU( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEEQU_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequ( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void cgeequ_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void CGEES( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEES_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgees( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgees_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEESX( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEESX_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgeesx( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgeesx_( const char* jobvs, const char* sort, MKL_C_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex8* a, const int* lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, const int* ldvs, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGEEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGS( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGS_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegs( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegs_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEGV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegv( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgegv_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEHD2( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEHD2_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgehd2( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgehd2_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEHRD( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEHRD_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgehrd( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgehrd_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGELQ2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGELQ2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgelq2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgelq2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGELQF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGELQF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgelqf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgelqf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGELSD( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGELSD_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgelsd( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgelsd_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGELS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CGELS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgels( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void cgels_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CGELSS( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGELSS_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelss( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelss_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* s, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGELSX( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void CGELSX_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void cgelsx( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void cgelsx_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* info ); void CGELSY( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGELSY_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelsy( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgelsy_( const int* m, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* jpvt, const float* rcond, int* rank, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEQL2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQL2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeql2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeql2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQLF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQLF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqlf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqlf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQP3( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEQP3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeqp3( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgeqp3_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGEQPF( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void CGEQPF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void cgeqpf( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void cgeqpf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork, int* info ); void CGEQR2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQR2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQR2P( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQR2P_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2p( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgeqr2p_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGEQRF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQRF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQRFP( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGEQRFP_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrfp( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgeqrfp_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGERFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGERFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgerfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgerfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGERQ2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGERQ2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgerq2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cgerq2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGERQF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGERQF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgerqf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cgerqf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CGESC2( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void CGESC2_( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void cgesc2( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void cgesc2_( const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* rhs, const int* ipiv, const int* jpiv, float* scale ); void CGESDD( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGESDD_( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgesdd( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void cgesdd_( const char* jobz, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* info ); void CGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex8* a, const int* lda, float* s, MKL_Complex8* u, const int* ldu, MKL_Complex8* vt, const int* ldvt, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGESV( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGESV_( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgesv( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgesv_( const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CGETC2( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void CGETC2_( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void cgetc2( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void cgetc2_( const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* jpiv, int* info ); void CGETF2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETF2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetf2( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetf2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETRF( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CGETRF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void cgetrf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void MKL_CGETRFNPI( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void MKL_CGETRFNPI_( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnpi( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void mkl_cgetrfnpi_( const int* m, const int* n, const int* nfact, MKL_Complex8* a, const int* lda, int* info ); void CGETRI( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CGETRI_( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void cgetri( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void cgetri_( const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CGETRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGETRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgetrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgetrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void cggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, MKL_Complex8* v, const int* ldv, int* info ); void CGGBAL( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void CGGBAL_( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void cggbal( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void cggbal_( const char* job, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void CGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void cgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, MKL_Complex8* work, const int* lwork, float* rwork, int* bwork, int* info ); void CGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void CGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void cggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void cggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_C_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, const int* ldvsl, MKL_Complex8* vsr, const int* ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void CGGEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGGEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cggev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void CGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void cggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void cggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* bwork, int* info ); void CGGGLM( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void CGGGLM_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void cggglm( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void cggglm_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, const int* lwork, int* info ); void CGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void CGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void cgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void cgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* info ); void CGGLSE( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void CGGLSE_( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void cgglse( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void cgglse_( const int* m, const int* n, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, const int* lwork, int* info ); void CGGQRF( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGQRF_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggqrf( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggqrf_( const int* n, const int* m, const int* p, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGRQF( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGRQF_( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggrqf( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void cggrqf_( const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* taua, MKL_Complex8* b, const int* ldb, MKL_Complex8* taub, MKL_Complex8* work, const int* lwork, int* info ); void CGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void cggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void cggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CGTCON( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CGTCON_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cgtcon( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cgtcon_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CGTRFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTRFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtrfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtrfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTSV( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CGTSV_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cgtsv( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cgtsv_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CGTTRF( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void CGTTRF_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void cgttrf( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void cgttrf_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv, int* info ); void CGTTRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGTTRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgttrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cgttrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CGTTS2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void CGTTS2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void cgtts2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void cgtts2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, const int* ldb ); void CHBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBEV( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbev( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbev_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void CHBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void chbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void chbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, const MKL_Complex8* bb, const int* ldbb, MKL_Complex8* x, const int* ldx, MKL_Complex8* work, float* rwork, int* info ); void CHBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex8* ab, const int* ldab, MKL_Complex8* bb, const int* ldbb, MKL_Complex8* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHBTRD( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CHBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void chbtrd( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void chbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CHECON( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHECON_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void checon_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHEEQUB( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CHEEQUB_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void cheequb( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void cheequb_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CHEEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEV( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void cheev_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEEVR( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVR_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cheevr_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void cheevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEGS2( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGS2_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegs2( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegs2_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGST( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGST_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegst( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void chegst_( const int* itype, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, int* info ); void CHEGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chegvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chegvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHEGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chegv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, float* w, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHEGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHEGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chegvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void chegvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* iwork, int* ifail, int* info ); void CHERFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHERFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cherfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cherfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHERFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHERFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cherfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cherfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHESV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void chesv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CHESVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHESVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chesvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chesvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHESVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHESVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void chesvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void chesvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CHETD2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void CHETD2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void chetd2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void chetd2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, int* info ); void CHETF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void chetf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CHETRD( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CHETRD_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void chetrd_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRI_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void chetri_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CHETRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHETRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chetrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void CHFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void chfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void chfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const MKL_Complex8* a, const int* lda, const float* beta, MKL_Complex8* c ); void CHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void chgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* t, const int* ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CHLA_TRANSTYPE( char* ret_val, int ret_val_len, const int* trans ); void CHLA_TRANSTYPE_( char* ret_val, int ret_val_len, const int* trans ); void chla_transtype( char* ret_val, int ret_val_len, const int* trans ); void chla_transtype_( char* ret_val, int ret_val_len, const int* trans ); void CHPCON( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHPCON_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void chpcon( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void chpcon_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CHPEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpevd( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPEV( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpev( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpev_( const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPGST( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void CHPGST_( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void chpgst( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void chpgst_( const int* itype, const char* uplo, const int* n, MKL_Complex8* ap, const MKL_Complex8* bp, int* info ); void CHPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpgvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void chpgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CHPGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpgv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void chpgv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* info ); void CHPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void chpgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex8* ap, MKL_Complex8* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail, int* info ); void CHPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chpsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chpsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chpsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void chpsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CHPTRD( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void CHPTRD_( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void chptrd( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void chptrd_( const char* uplo, const int* n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau, int* info ); void CHPTRF( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CHPTRF_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void chptrf( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void chptrf_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CHPTRI( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CHPTRI_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void chptri( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void chptri_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CHPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void chptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CHSEIN( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void CHSEIN_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void chsein( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void chsein_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr, int* info ); void CHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void chseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void chseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLABRD( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void CLABRD_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void clabrd( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void clabrd_( const int* m, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy ); void CLACGV( const int* n, MKL_Complex8* x, const int* incx ); void CLACGV_( const int* n, MKL_Complex8* x, const int* incx ); void clacgv( const int* n, MKL_Complex8* x, const int* incx ); void clacgv_( const int* n, MKL_Complex8* x, const int* incx ); void CLACN2( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void CLACN2_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void clacn2( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void clacn2_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); void CLACON( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void CLACON_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void clacon( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void clacon_( const int* n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase ); void CLACP2( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACP2_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacp2( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacp2_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACPY( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACPY_( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacpy( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void clacpy_( const char* uplo, const int* m, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb ); void CLACRM( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLACRM_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clacrm( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clacrm_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const float* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLACRT( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void CLACRT_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void clacrt( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void clacrt_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const MKL_Complex8* c, const MKL_Complex8* s ); void CLADIV( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void CLADIV_( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void cladiv( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void cladiv_( MKL_Complex8* ret_value, const MKL_Complex8* x, const MKL_Complex8* y ); void CLAED0( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void CLAED0_( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void claed0( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void claed0_( const int* qsiz, const int* n, float* d, float* e, MKL_Complex8* q, const int* ldq, MKL_Complex8* qstore, const int* ldqs, float* rwork, int* iwork, int* info ); void CLAED7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CLAED7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void claed7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void claed7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, MKL_Complex8* q, const int* ldq, const float* rho, int* indxq, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CLAED8( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void CLAED8_( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void claed8( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void claed8_( int* k, const int* n, const int* qsiz, MKL_Complex8* q, const int* ldq, float* d, float* rho, const int* cutpnt, const float* z, float* dlamda, MKL_Complex8* q2, const int* ldq2, float* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, float* givnum, int* info ); void CLAEIN( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void CLAEIN_( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void claein( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void claein_( const int* rightv, const int* noinit, const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* w, MKL_Complex8* v, MKL_Complex8* b, const int* ldb, float* rwork, const float* eps3, const float* smlnum, int* info ); void CLAESY( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void CLAESY_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void claesy( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void claesy_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, MKL_Complex8* rt1, MKL_Complex8* rt2, MKL_Complex8* evscal, MKL_Complex8* cs1, MKL_Complex8* sn1 ); void CLAEV2( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void CLAEV2_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void claev2( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void claev2_( const MKL_Complex8* a, const MKL_Complex8* b, const MKL_Complex8* c, float* rt1, float* rt2, float* cs1, MKL_Complex8* sn1 ); void CLAG2Z( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void CLAG2Z_( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void clag2z( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void clag2z_( const int* m, const int* n, const MKL_Complex8* sa, const int* ldsa, MKL_Complex16* a, const int* lda, int* info ); void CLAGS2( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void CLAGS2_( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void clags2( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void clags2_( const int* upper, const float* a1, const MKL_Complex8* a2, const float* a3, const float* b1, const MKL_Complex8* b2, const float* b3, float* csu, MKL_Complex8* snu, float* csv, MKL_Complex8* snv, float* csq, MKL_Complex8* snq ); void CLAGTM( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void CLAGTM_( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void clagtm( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void clagtm_( const char* trans, const int* n, const int* nrhs, const float* alpha, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* x, const int* ldx, const float* beta, MKL_Complex8* b, const int* ldb ); void CLAHEF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHEF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clahef_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void CLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void clahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void clahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* info ); void CLAHR2( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAHR2_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahr2( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahr2_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAHRD( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAHRD_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahrd( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void clahrd_( const int* n, const int* k, const int* nb, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* t, const int* ldt, MKL_Complex8* y, const int* ldy ); void CLAIC1( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void CLAIC1_( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void claic1( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void claic1_( const int* job, const int* j, const MKL_Complex8* x, const float* sest, const MKL_Complex8* w, const MKL_Complex8* gamma, float* sestpr, MKL_Complex8* s, MKL_Complex8* c ); void CLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void CLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void clals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void clals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* rwork, int* info ); void CLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void CLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void clalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void clalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex8* b, const int* ldb, MKL_Complex8* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* rwork, int* iwork, int* info ); void CLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void CLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void clalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); void clalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, MKL_Complex8* b, const int* ldb, const float* rcond, int* rank, MKL_Complex8* work, float* rwork, int* iwork, int* info ); float CLANGB( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float clangb( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float clangb_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANGE( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANGE_( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clange( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clange_( const char* norm, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANGT( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float CLANGT_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float clangt( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float clangt_( const char* norm, const int* n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du ); float CLANHB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANHB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clanhb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clanhb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANHE( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHE_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhe( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhe_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHF( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float CLANHF_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float clanhf( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float clanhf_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, float* work ); float CLANHP( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANHP_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clanhp( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clanhp_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANHS( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHS_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhs( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clanhs_( const char* norm, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANHT( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float CLANHT_( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float clanht( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float clanht_( const char* norm, const int* n, const float* d, const MKL_Complex8* e ); float CLANSB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clansb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clansb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANSP( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANSP_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clansp( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float clansp_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* ap, float* work ); float CLANSY( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANSY_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clansy( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clansy_( const char* norm, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float clantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex8* ab, const int* ldab, float* work ); float CLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float CLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float clantp( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float clantp_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* work ); float CLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float CLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); float clantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex8* a, const int* lda, float* work ); void CLAPLL( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void CLAPLL_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void clapll( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void clapll_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* ssmin ); void CLAPMT( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void CLAPMT_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmt( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void clapmt_( const int* forwrd, const int* m, const int* n, MKL_Complex8* x, const int* ldx, int* k ); void CLAQGB( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQGB_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqgb( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqgb_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex8* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQGE( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQGE_( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqge( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void claqge_( const int* m, const int* n, MKL_Complex8* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void CLAQHB( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void CLAQHB_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void claqhb( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void claqhb_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, float* s, const float* scond, const float* amax, char* equed ); void CLAQHE( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAQHE_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqhe( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqhe_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAQHP( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQHP_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqhp( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqhp_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQP2( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void CLAQP2_( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void claqp2( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void claqp2_( const int* m, const int* n, const int* offset, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* work ); void CLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void CLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void claqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void claqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* jpvt, MKL_Complex8* tau, float* vn1, float* vn2, MKL_Complex8* auxv, MKL_Complex8* f, const int* ldf ); void CLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR1( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void CLAQR1_( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void claqr1( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void claqr1_( const int* n, const MKL_Complex8* h, const int* ldh, const MKL_Complex8* s1, MKL_Complex8* s2, MKL_Complex8* v ); void CLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void claqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, int* ns, int* nd, MKL_Complex8* sh, MKL_Complex8* v, const int* ldv, const int* nh, MKL_Complex8* t, const int* ldt, const int* nv, MKL_Complex8* wv, const int* ldwv, MKL_Complex8* work, const int* lwork ); void CLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void claqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex8* h, const int* ldh, MKL_Complex8* w, int* iloz, int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void CLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void claqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void claqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex8* s, MKL_Complex8* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex8* z, const int* ldz, MKL_Complex8* v, const int* ldv, MKL_Complex8* u, const int* ldu, const int* nv, MKL_Complex8* wv, const int* ldwv, const int* nh, MKL_Complex8* wh, const int* ldwh ); void CLAQSB( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSB_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void claqsb( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void claqsb_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSP( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSP_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqsp( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void claqsp_( const char* uplo, const int* n, MKL_Complex8* ap, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSY( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAQSY_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqsy( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void claqsy_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void CLAR1V( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void CLAR1V_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void clar1v( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void clar1v_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, MKL_Complex8* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void CLAR2V( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void CLAR2V_( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void clar2v( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void clar2v_( const int* n, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* z, const int* incx, const float* c, const MKL_Complex8* s, const int* incc ); void CLARCM( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLARCM_( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clarcm( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void clarcm_( const int* m, const int* n, const float* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* rwork ); void CLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARF( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARF_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarf( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarf_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARFG( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFG_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfg( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfg_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFGP( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFGP_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfgp( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfgp_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFP( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFP_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfp( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void clarfp_( const int* n, MKL_Complex8* alpha, MKL_Complex8* x, const int* incx, MKL_Complex8* tau ); void CLARFT( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLARFT_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarft( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarft_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLARFX( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARFX_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfx( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarfx_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARGV( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void CLARGV_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void clargv( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void clargv_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, float* c, const int* incc ); void CLARNV( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void CLARNV_( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void clarnv( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void clarnv_( const int* idist, int* iseed, const int* n, MKL_Complex8* x ); void CLARRV( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void CLARRV_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void clarrv( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void clarrv_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void CLARSCL2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLARSCL2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clarscl2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clarscl2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLARTG( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void CLARTG_( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void clartg( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void clartg_( const MKL_Complex8* f, const MKL_Complex8* g, float* cs, MKL_Complex8* sn, MKL_Complex8* r ); void CLARTV( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void CLARTV_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void clartv( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void clartv_( const int* n, MKL_Complex8* x, const int* incx, MKL_Complex8* y, const int* incy, const float* c, const MKL_Complex8* s, const int* incc ); void CLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void clarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* ldwork ); void CLARZ( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARZ_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarz( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void clarz_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work ); void CLARZT( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLARZT_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarzt( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void clarzt_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex8* v, const int* ldv, const MKL_Complex8* tau, MKL_Complex8* t, const int* ldt ); void CLASCL( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLASCL_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clascl( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clascl_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLASCL2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLASCL2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clascl2( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void clascl2_( const int* m, const int* n, const float* d, MKL_Complex8* x, const int* ldx ); void CLASET( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void CLASET_( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void claset( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void claset_( const char* uplo, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* beta, MKL_Complex8* a, const int* lda ); void CLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void CLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void clasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void clasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, MKL_Complex8* a, const int* lda ); void CLASSQ( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void CLASSQ_( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void classq( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void classq_( const int* n, const MKL_Complex8* x, const int* incx, float* scale, float* sumsq ); void CLASWP( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void CLASWP_( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void claswp( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void claswp_( const int* n, MKL_Complex8* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void CLASYF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLASYF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void clasyf_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* w, const int* ldw, int* info ); void CLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATDF( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void CLATDF_( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void clatdf( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void clatdf_( const int* ijob, const int* n, const MKL_Complex8* z, const int* ldz, MKL_Complex8* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void CLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* ap, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATRD( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void CLATRD_( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void clatrd( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void clatrd_( const char* uplo, const int* n, const int* nb, MKL_Complex8* a, const int* lda, float* e, MKL_Complex8* tau, MKL_Complex8* w, const int* ldw ); void CLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void clatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* x, float* scale, float* cnorm, int* info ); void CLATRZ( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void CLATRZ_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void clatrz( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void clatrz_( const int* m, const int* n, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work ); void CLATZM( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void CLATZM_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void clatzm( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void clatzm_( const char* side, const int* m, const int* n, const MKL_Complex8* v, const int* incv, const MKL_Complex8* tau, MKL_Complex8* c1, MKL_Complex8* c2, const int* ldc, MKL_Complex8* work ); void CLAUU2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLAUU2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauu2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauu2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLAUUM( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CLAUUM_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauum( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void clauum_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPBCON( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPBCON_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpbcon( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpbcon_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPBEQU( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void CPBEQU_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void cpbequ( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void cpbequ_( const char* uplo, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void CPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBSTF( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBSTF_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbstf( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbstf_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex8* ab, const int* ldab, MKL_Complex8* afb, const int* ldafb, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPBTF2( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTF2_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtf2( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtf2_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTRF( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTRF_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtrf( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void cpbtrf_( const char* uplo, const int* n, const int* kd, MKL_Complex8* ab, const int* ldab, int* info ); void CPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void cpbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CPFTRF( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRF_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftrf( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftrf_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRI( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRI_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftri( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void cpftri_( const char* transr, const char* uplo, const int* n, MKL_Complex8* a, int* info ); void CPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void CPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void cpftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void cpftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb, int* info ); void CPOCON( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPOCON_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpocon( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cpocon_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPOEQUB( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPOEQUB_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequb( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequb_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPOEQU( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPOEQU_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequ( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void cpoequ_( const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, int* info ); void CPORFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPORFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cporfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cporfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPOSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPOSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cposv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cposv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void cposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CPOTF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRI( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRI_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotri( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void cpotri_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CPOTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPOTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cpotrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void cpotrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CPPCON( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPPCON_( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cppcon( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void cppcon_( const char* uplo, const int* n, const MKL_Complex8* ap, const float* anorm, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CPPEQU( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void CPPEQU_( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void cppequ( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void cppequ_( const char* uplo, const int* n, const MKL_Complex8* ap, float* s, float* scond, float* amax, int* info ); void CPPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cpprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cppsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cppsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPPTRF( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRF_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptrf( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptrf_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRI( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRI_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptri( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void cpptri_( const char* uplo, const int* n, MKL_Complex8* ap, int* info ); void CPPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cpptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void cpptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CPSTF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPSTF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPSTRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPSTRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void cpstrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void CPTCON( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void CPTCON_( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void cptcon( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void cptcon_( const int* n, const float* d, const MKL_Complex8* e, const float* anorm, float* rcond, float* rwork, int* info ); void CPTEQR( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CPTEQR_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void cpteqr( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void cpteqr_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CPTRFS( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTRFS_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptrfs( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptrfs_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTSV( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTSV_( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cptsv( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cptsv_( const int* n, const int* nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTSVX( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTSVX_( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptsvx( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cptsvx_( const char* fact, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CPTTRF( const int* n, float* d, MKL_Complex8* e, int* info ); void CPTTRF_( const int* n, float* d, MKL_Complex8* e, int* info ); void cpttrf( const int* n, float* d, MKL_Complex8* e, int* info ); void cpttrf_( const int* n, float* d, MKL_Complex8* e, int* info ); void CPTTRS( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTTRS_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cpttrs( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void cpttrs_( const char* uplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb, int* info ); void CPTTS2( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void CPTTS2_( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void cptts2( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void cptts2_( const int* iuplo, const int* n, const int* nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, const int* ldb ); void CROT( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void CROT_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void crot( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void crot_( const int* n, MKL_Complex8* cx, const int* incx, MKL_Complex8* cy, const int* incy, const float* c, const MKL_Complex8* s ); void CSPCON( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSPCON_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cspcon( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void cspcon_( const char* uplo, const int* n, const MKL_Complex8* ap, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSPMV( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSPMV_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void cspmv( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void cspmv_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* ap, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSPR( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void CSPR_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void cspr( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void cspr_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* ap ); void CSPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cspsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void cspsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void cspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSPTRF( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CSPTRF_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void csptrf( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void csptrf_( const char* uplo, const int* n, MKL_Complex8* ap, int* ipiv, int* info ); void CSPTRI( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CSPTRI_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void csptri( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void csptri_( const char* uplo, const int* n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work, int* info ); void CSPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSRSCL( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void CSRSCL_( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void csrscl( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void csrscl_( const int* n, const float* sa, MKL_Complex8* sx, const int* incx ); void CSTEDC( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CSTEDC_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cstedc( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void cstedc_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, float* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void CSTEGR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEGR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstegr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstegr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, MKL_Complex8* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEIN( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void CSTEIN_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void cstein( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void cstein_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void CSTEMR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEMR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstemr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void cstemr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, MKL_Complex8* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CSTEQR( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CSTEQR_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void csteqr( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void csteqr_( const char* compz, const int* n, float* d, float* e, MKL_Complex8* z, const int* ldz, float* work, int* info ); void CSYCON( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYCON_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void csycon_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, MKL_Complex8* work, int* info ); void CSYEQUB( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CSYEQUB_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void csyequb( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void csyequb_( char* uplo, const int* n, const MKL_Complex8* a, const int* lda, float* s, float* scond, float* amax, MKL_Complex8* work, int* info ); void CSYMV( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSYMV_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void csymv( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void csymv_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const MKL_Complex8* beta, MKL_Complex8* y, const int* incy ); void CSYR( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void CSYR_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void csyr( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void csyr_( const char* uplo, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* x, const int* incx, MKL_Complex8* a, const int* lda ); void CSYRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSYRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csyrfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void csyrfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void csysv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* lwork, int* info ); void CSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void csysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void csysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, const MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, const int* lwork, float* rwork, int* info ); void CSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void csysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex8* a, const int* lda, MKL_Complex8* af, const int* ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, const int* ldb, MKL_Complex8* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, MKL_Complex8* work, float* rwork, int* info ); void CSYTF2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTF2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void csytf2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, int* info ); void CSYTRF( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRF_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void csytrf_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CSYTRI( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRI_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void csytri_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, int* info ); void CSYTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CSYTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void csytrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* b, const int* ldb, int* info ); void CTBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex8* ab, const int* ldab, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CTBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void ctbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void ctbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex8* ab, const int* ldab, MKL_Complex8* b, const int* ldb, int* info ); void CTFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void CTFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void ctfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void ctfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex8* alpha, const MKL_Complex8* a, MKL_Complex8* b, const int* ldb ); void CTFTRI( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void CTFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void ctftri( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void ctftri_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex8* a, int* info ); void CTFTTP( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void CTFTTP_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void ctfttp( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void ctfttp_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* ap, int* info ); void CTFTTR( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void CTFTTR_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void ctfttr( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void ctfttr_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* arf, MKL_Complex8* a, const int* lda, int* info ); void CTGEVC( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTGEVC_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctgevc( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctgevc_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex8* s, const int* lds, const MKL_Complex8* p, const int* ldp, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTGEX2( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void CTGEX2_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void ctgex2( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void ctgex2_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* j1, int* info ); void CTGEXC( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void CTGEXC_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ctgexc( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ctgexc_( const int* wantq, const int* wantz, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, const int* ifst, int* ilst, int* info ); void CTGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CTGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ctgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ctgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, const int* ldq, MKL_Complex8* z, const int* ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, const int* liwork, int* info ); void CTGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void CTGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void ctgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void ctgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, MKL_Complex8* u, const int* ldu, MKL_Complex8* v, const int* ldv, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* ncycle, int* info ); void CTGSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTGSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTGSY2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void CTGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void ctgsy2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void ctgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* info ); void CTGSYL( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsyl( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void ctgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, const MKL_Complex8* d, const int* ldd, const MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, float* scale, float* dif, MKL_Complex8* work, const int* lwork, int* iwork, int* info ); void CTPCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctpcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTPTRI( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void CTPTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void ctptri( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void ctptri_( const char* uplo, const char* diag, const int* n, MKL_Complex8* ap, int* info ); void CTPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CTPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void ctptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void ctptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* ap, MKL_Complex8* b, const int* ldb, int* info ); void CTPTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void CTPTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void ctpttf( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void ctpttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* arf, int* info ); void CTPTTR( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void CTPTTR_( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void ctpttr( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void ctpttr_( const char* uplo, const int* n, const MKL_Complex8* ap, MKL_Complex8* a, const int* lda, int* info ); void CTRCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctrcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void ctrcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex8* a, const int* lda, float* rcond, MKL_Complex8* work, float* rwork, int* info ); void CTREVC( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTREVC_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctrevc( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void ctrevc_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* vl, const int* ldvl, MKL_Complex8* vr, const int* ldvr, const int* mm, int* m, MKL_Complex8* work, float* rwork, int* info ); void CTREXC( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void CTREXC_( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ctrexc( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ctrexc_( const char* compq, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void CTRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctrrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void ctrrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, const MKL_Complex8* x, const int* ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork, int* info ); void CTRSEN( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void CTRSEN_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void ctrsen( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void ctrsen_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex8* t, const int* ldt, MKL_Complex8* q, const int* ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, const int* lwork, int* info ); void CTRSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void CTRSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void ctrsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void ctrsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex8* t, const int* ldt, const MKL_Complex8* vl, const int* ldvl, const MKL_Complex8* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, MKL_Complex8* work, const int* ldwork, float* rwork, int* info ); void CTRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void CTRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void ctrsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void ctrsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, float* scale, int* info ); void CTRTI2( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTI2_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrti2( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrti2_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTRI( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrtri( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void ctrtri_( const char* uplo, const char* diag, const int* n, MKL_Complex8* a, const int* lda, int* info ); void CTRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CTRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void ctrtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void ctrtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, int* info ); void CTRTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void CTRTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void ctrttf( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void ctrttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* arf, int* info ); void CTRTTP( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void CTRTTP_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void ctrttp( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void ctrttp_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, MKL_Complex8* ap, int* info ); void CTZRQF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void CTZRQF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void ctzrqf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void ctzrqf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, int* info ); void CTZRZF( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CTZRZF_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void ctzrzf( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void ctzrzf_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNG2L( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNG2L_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2l( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2l_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNG2R( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNG2R_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2r( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cung2r_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGBR( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGBR_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungbr( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungbr_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGHR( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGHR_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunghr( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunghr_( const int* n, const int* ilo, const int* ihi, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGL2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGL2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungl2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungl2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGLQ( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGLQ_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunglq( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cunglq_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQL( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQL_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungql( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungql_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQR( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGQR_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungqr( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungqr_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGR2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGR2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungr2( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void cungr2_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, int* info ); void CUNGRQ( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGRQ_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungrq( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungrq_( const int* m, const int* n, const int* k, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGTR( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNGTR_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungtr( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void cungtr_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* work, const int* lwork, int* info ); void CUNM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmql( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cunmr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUNMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUNMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void cunmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, const int* lwork, int* info ); void CUPGTR( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CUPGTR_( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void cupgtr( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void cupgtr_( const char* uplo, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, const int* ldq, MKL_Complex8* work, int* info ); void CUPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void CUPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cupmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void cupmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, const int* ldc, MKL_Complex8* work, int* info ); void DBDSDC( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void DBDSDC_( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void dbdsdc( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void dbdsdc_( const char* uplo, const char* compq, const int* n, double* d, double* e, double* u, const int* ldu, double* vt, const int* ldvt, double* q, int* iq, double* work, int* iwork, int* info ); void DBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DDISNA( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void DDISNA_( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void ddisna( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void ddisna_( const char* job, const int* m, const int* n, const double* d, double* sep, int* info ); void DGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void DGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void dgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void dgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* pt, const int* ldpt, double* c, const int* ldc, double* work, int* info ); void DGBCON( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgbcon( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequb( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequb_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBEQU( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequ( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgbequ_( const int* m, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void DGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void dgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void dgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, int* ipiv, double* b, const int* ldb, int* info ); void DGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGBTF2( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTF2_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtf2( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtf2_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTRF( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTRF_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtrf( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void dgbtrf_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, int* ipiv, int* info ); void DGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void DGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void dgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void dgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const int* ipiv, double* b, const int* ldb, int* info ); void DGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void DGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void dgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void dgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, double* v, const int* ldv, int* info ); void DGEBAL( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void DGEBAL_( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void dgebal( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void dgebal_( const char* job, const int* n, double* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void DGEBD2( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void DGEBD2_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void dgebd2( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void dgebd2_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, int* info ); void DGEBRD( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void DGEBRD_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void dgebrd( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void dgebrd_( const int* m, const int* n, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* work, const int* lwork, int* info ); void DGECON( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGECON_( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgecon( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgecon_( const char* norm, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGEEQUB( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEEQUB_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequb( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequb_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEEQU( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEEQU_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequ( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void dgeequ_( const int* m, const int* n, const double* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void DGEES( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void DGEES_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void dgees( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void dgees_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* work, const int* lwork, int* bwork, int* info ); void DGEESX( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGEESX_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dgeesx( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dgeesx_( const char* jobvs, const char* sort, MKL_D_SELECT_FUNCTION_2 select, const char* sense, const int* n, double* a, const int* lda, int* sdim, double* wr, double* wi, double* vs, const int* ldvs, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGEEV( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEEV_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgeev( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgeev_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void DGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void dgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void dgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* wr, double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* info ); void DGEGS( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void DGEGS_( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void dgegs( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void dgegs_( const char* jobvsl, const char* jobvsr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* info ); void DGEGV( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEGV_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgegv( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dgegv_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGEHD2( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void DGEHD2_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void dgehd2( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void dgehd2_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, int* info ); void DGEHRD( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEHRD_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgehrd( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgehrd_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEJSV( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void DGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void dgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void dgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, double* a, const int* lda, double* sva, double* u, const int* ldu, double* v, const int* ldv, double* work, const int* lwork, int* iwork, int* info ); void DGELQ2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGELQ2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgelq2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgelq2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGELQF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGELQF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgelqf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgelqf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGELSD( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void DGELSD_( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void dgelsd( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void dgelsd_( const int* m, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* iwork, int* info ); void DGELS( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DGELS_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgels( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dgels_( const char* trans, const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DGELSS( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGELSS_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelss( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelss_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, double* s, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGELSX( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void DGELSX_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void dgelsx( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void dgelsx_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, int* info ); void DGELSY( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGELSY_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelsy( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void dgelsy_( const int* m, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* jpvt, const double* rcond, int* rank, double* work, const int* lwork, int* info ); void DGEQL2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQL2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeql2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeql2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQLF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQLF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqlf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqlf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQP3( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void DGEQP3_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void dgeqp3( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void dgeqp3_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, const int* lwork, int* info ); void DGEQPF( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void DGEQPF_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void dgeqpf( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void dgeqpf_( const int* m, const int* n, double* a, const int* lda, int* jpvt, double* tau, double* work, int* info ); void DGEQR2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQR2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQR2P( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQR2P_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2p( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgeqr2p_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGEQRF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQRF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQRFP( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGEQRFP_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrfp( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgeqrfp_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGERFS( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGERFS_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgerfs( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgerfs_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGERQ2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGERQ2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgerq2( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void dgerq2_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, int* info ); void DGERQF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGERQF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgerqf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dgerqf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DGESC2( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void DGESC2_( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void dgesc2( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void dgesc2_( const int* n, const double* a, const int* lda, double* rhs, const int* ipiv, const int* jpiv, double* scale ); void DGESDD( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void DGESDD_( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesdd( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void dgesdd_( const char* jobz, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* iwork, int* info ); void DGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void DGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void dgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void dgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, double* a, const int* lda, double* s, double* u, const int* ldu, double* vt, const int* ldvt, double* work, const int* lwork, int* info ); void DGESV( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void DGESV_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void dgesv( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void dgesv_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, int* info ); void DGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void DGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void dgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void dgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, double* a, const int* lda, double* sva, const int* mv, double* v, const int* ldv, double* work, const int* lwork, int* info ); void DGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DGETC2( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void DGETC2_( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void dgetc2( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void dgetc2_( const int* n, double* a, const int* lda, int* ipiv, int* jpiv, int* info ); void DGETF2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETF2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetf2( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetf2_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETRF( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DGETRF_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dgetrf_( const int* m, const int* n, double* a, const int* lda, int* ipiv, int* info ); void MKL_DGETRFNPI( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void MKL_DGETRFNPI_( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void mkl_dgetrfnpi( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void mkl_dgetrfnpi_( const int* m, const int* n, const int* nfact, double* a, const int* lda, int* info ); void DGETRI( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void DGETRI_( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dgetri( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void dgetri_( const int* n, double* a, const int* lda, const int* ipiv, double* work, const int* lwork, int* info ); void DGETRS( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DGETRS_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dgetrs( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dgetrs_( const char* trans, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void DGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void dggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void dggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, double* v, const int* ldv, int* info ); void DGGBAL( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void DGGBAL_( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void dggbal( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void dggbal_( const char* job, const int* n, double* a, const int* lda, double* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void DGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void DGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void dgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* work, const int* lwork, int* bwork, int* info ); void DGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void dggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_D_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, const int* ldvsl, double* vsr, const int* ldvsr, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void DGGEV( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGGEV_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void dggev_( const char* jobvl, const char* jobvr, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, double* work, const int* lwork, int* info ); void DGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void DGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void dggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void dggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* vl, const int* ldvl, double* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, const int* lwork, int* iwork, int* bwork, int* info ); void DGGGLM( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void DGGGLM_( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void dggglm( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void dggglm_( const int* n, const int* m, const int* p, double* a, const int* lda, double* b, const int* ldb, double* d, double* x, double* y, double* work, const int* lwork, int* info ); void DGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void DGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void dgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void dgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* info ); void DGGLSE( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void DGGLSE_( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void dgglse( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void dgglse_( const int* m, const int* n, const int* p, double* a, const int* lda, double* b, const int* ldb, double* c, double* d, double* x, double* work, const int* lwork, int* info ); void DGGQRF( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGQRF_( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggqrf( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggqrf_( const int* n, const int* m, const int* p, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGRQF( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGRQF_( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggrqf( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void dggrqf_( const int* m, const int* p, const int* n, double* a, const int* lda, double* taua, double* b, const int* ldb, double* taub, double* work, const int* lwork, int* info ); void DGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void DGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void dggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void dggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, double* a, const int* lda, double* b, const int* ldb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* iwork, int* info ); void DGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void DGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void dggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void dggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, int* iwork, double* tau, double* work, int* info ); void DGSVJ0( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGSVJ0_( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj0( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj0_( const char* jobv, const int* m, const int* n, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj1( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void dgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, double* a, const int* lda, double* d, double* sva, const int* mv, double* v, const int* ldv, const double* eps, const double* sfmin, const double* tol, const int* nsweep, double* work, const int* lwork, int* info ); void DGTCON( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGTCON_( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgtcon( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dgtcon_( const char* norm, const int* n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DGTRFS( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTRFS_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtrfs( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtrfs_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTSV( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void DGTSV_( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void dgtsv( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void dgtsv_( const int* n, const int* nrhs, double* dl, double* d, double* du, double* b, const int* ldb, int* info ); void DGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DGTTRF( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void DGTTRF_( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void dgttrf( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void dgttrf_( const int* n, double* dl, double* d, double* du, double* du2, int* ipiv, int* info ); void DGTTRS( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void DGTTRS_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void dgttrs( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void dgttrs_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb, int* info ); void DGTTS2( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void DGTTS2_( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void dgtts2( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void dgtts2_( const int* itrans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, const int* ldb ); void DHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* t, const int* ldt, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DHSEIN( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void DHSEIN_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void dhsein( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void dhsein_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const double* h, const int* ldh, double* wr, const double* wi, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* ifaill, int* ifailr, int* info ); void DHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dhseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, double* z, const int* ldz, double* work, const int* lwork, int* info ); int DISNAN( const double* din ); int DISNAN_( const double* din ); int disnan( const double* din ); int disnan_( const double* din ); void DLABAD( double* smallx, double* large ); void DLABAD_( double* smallx, double* large ); void dlabad( double* smallx, double* large ); void dlabad_( double* smallx, double* large ); void DLABRD( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void DLABRD_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void dlabrd( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void dlabrd_( const int* m, const int* n, const int* nb, double* a, const int* lda, double* d, double* e, double* tauq, double* taup, double* x, const int* ldx, double* y, const int* ldy ); void DLACN2( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void DLACN2_( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void dlacn2( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void dlacn2_( const int* n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); void DLACON( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void DLACON_( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void dlacon( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void dlacon_( const int* n, double* v, double* x, int* isgn, double* est, int* kase ); void DLACPY( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void DLACPY_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void dlacpy( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void dlacpy_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, double* b, const int* ldb ); void DLADIV( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void DLADIV_( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void dladiv( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void dladiv_( const double* a, const double* b, const double* c, const double* d, double* p, double* q ); void DLAE2( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void DLAE2_( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void dlae2( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void dlae2_( const double* a, const double* b, const double* c, double* rt1, double* rt2 ); void DLAEBZ( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void DLAEBZ_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void dlaebz( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void dlaebz_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const double* abstol, const double* reltol, const double* pivmin, const double* d, const double* e, const double* e2, int* nval, double* ab, double* c, int* mout, int* nab, double* work, int* iwork, int* info ); void DLAED0( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void DLAED0_( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void dlaed0( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void dlaed0_( const int* icompq, const int* qsiz, const int* n, double* d, const double* e, double* q, const int* ldq, double* qstore, const int* ldqs, double* work, int* iwork, int* info ); void DLAED1( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void DLAED1_( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void dlaed1( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void dlaed1_( const int* n, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* work, int* iwork, int* info ); void DLAED2( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void DLAED2_( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void dlaed2( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void dlaed2_( int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, int* indxq, double* rho, const double* z, double* dlamda, double* w, double* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void DLAED3( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void DLAED3_( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void dlaed3( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void dlaed3_( const int* k, const int* n, const int* n1, double* d, double* q, const int* ldq, const double* rho, double* dlamda, const double* q2, const int* indx, const int* ctot, double* w, double* s, int* info ); void DLAED4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void DLAED4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void dlaed4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void dlaed4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam, int* info ); void DLAED5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void DLAED5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void dlaed5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void dlaed5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dlam ); void DLAED6( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void DLAED6_( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void dlaed6( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void dlaed6_( const int* kniter, const int* orgati, const double* rho, const double* d, const double* z, const double* finit, double* tau, int* info ); void DLAED7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void DLAED7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void dlaed7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void dlaed7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, double* q, const int* ldq, int* indxq, const double* rho, const int* cutpnt, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, double* work, int* iwork, int* info ); void DLAED8( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void DLAED8_( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void dlaed8( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void dlaed8_( const int* icompq, int* k, const int* n, const int* qsiz, double* d, double* q, const int* ldq, const int* indxq, double* rho, const int* cutpnt, const double* z, double* dlamda, double* q2, const int* ldq2, double* w, int* perm, int* givptr, int* givcol, double* givnum, int* indxp, int* indx, int* info ); void DLAED9( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void DLAED9_( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void dlaed9( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void dlaed9_( const int* k, const int* kstart, const int* kstop, const int* n, double* d, double* q, const int* ldq, const double* rho, const double* dlamda, const double* w, double* s, const int* lds, int* info ); void DLAEDA( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void DLAEDA_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void dlaeda( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void dlaeda_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, const double* q, const int* qptr, double* z, double* ztemp, int* info ); void DLAEIN( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void DLAEIN_( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void dlaein( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void dlaein_( const int* rightv, const int* noinit, const int* n, const double* h, const int* ldh, const double* wr, const double* wi, double* vr, double* vi, double* b, const int* ldb, double* work, const double* eps3, const double* smlnum, const double* bignum, int* info ); void DLAEV2( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void DLAEV2_( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void dlaev2( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void dlaev2_( const double* a, const double* b, const double* c, double* rt1, double* rt2, double* cs1, double* sn1 ); void DLAEXC( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void DLAEXC_( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void dlaexc( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void dlaexc_( const int* wantq, const int* n, double* t, const int* ldt, double* q, const int* ldq, const int* j1, const int* n1, const int* n2, double* work, int* info ); void DLAG2( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void DLAG2_( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void dlag2( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void dlag2_( const double* a, const int* lda, const double* b, const int* ldb, const double* safmin, double* scale1, double* scale2, double* wr1, double* wr2, double* wi ); void DLAG2S( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLAG2S_( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlag2s( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlag2s_( const int* m, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLAGS2( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void DLAGS2_( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void dlags2( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void dlags2_( const int* upper, const double* a1, const double* a2, const double* a3, const double* b1, const double* b2, const double* b3, double* csu, double* snu, double* csv, double* snv, double* csq, double* snq ); void DLAGTF( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void DLAGTF_( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void dlagtf( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void dlagtf_( const int* n, double* a, const double* lambda, double* b, double* c, const double* tol, double* d, int* in, int* info ); void DLAGTM( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void DLAGTM_( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void dlagtm( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void dlagtm_( const char* trans, const int* n, const int* nrhs, const double* alpha, const double* dl, const double* d, const double* du, const double* x, const int* ldx, const double* beta, double* b, const int* ldb ); void DLAGTS( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void DLAGTS_( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void dlagts( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void dlagts_( const int* job, const int* n, const double* a, const double* b, const double* c, const double* d, const int* in, double* y, double* tol, int* info ); void DLAGV2( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void DLAGV2_( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void dlagv2( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void dlagv2_( double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* csl, double* snl, double* csr, double* snr ); void DLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void DLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void dlahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void dlahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, int* info ); void DLAHR2( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAHR2_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahr2( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahr2_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAHRD( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAHRD_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahrd( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void dlahrd_( const int* n, const int* k, const int* nb, double* a, const int* lda, double* tau, double* t, const int* ldt, double* y, const int* ldy ); void DLAIC1( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); void DLAIC1_( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); void dlaic1( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); void dlaic1_( const int* job, const int* j, const double* x, const double* sest, const double* w, const double* gamma, double* sestpr, double* s, double* c ); int DLAISNAN( const double* din1, const double* din2 ); int DLAISNAN_( const double* din1, const double* din2 ); int dlaisnan( const double* din1, const double* din2 ); int dlaisnan_( const double* din1, const double* din2 ); void DLALN2( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void DLALN2_( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void dlaln2( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void dlaln2_( const int* ltrans, const int* na, const int* nw, const double* smin, const double* ca, const double* a, const int* lda, const double* d1, const double* d2, const double* b, const int* ldb, const double* wr, const double* wi, double* x, const int* ldx, double* scale, double* xnorm, int* info ); void DLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void DLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void dlals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void dlals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* work, int* info ); void DLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void DLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void dlalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void dlalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, double* b, const int* ldb, double* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* work, int* iwork, int* info ); void DLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); void DLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); void dlalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); void dlalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, const double* rcond, int* rank, double* work, int* iwork, int* info ); double DLAMCH( const char* cmach ); double DLAMCH_( const char* cmach ); double dlamch( const char* cmach ); double dlamch_( const char* cmach ); void DLAMC1( int* beta, int* t, int* rnd, int* ieee1 ); void DLAMC1_( int* beta, int* t, int* rnd, int* ieee1 ); void dlamc1( int* beta, int* t, int* rnd, int* ieee1 ); void dlamc1_( int* beta, int* t, int* rnd, int* ieee1 ); void DLAMC2( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); void DLAMC2_( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); void dlamc2( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); void dlamc2_( int* beta, int* t, int* rnd, double* eps, int* emin, double* rmin, int* emax, double* rmax ); double DLAMC3( const double* a, const double* b ); double DLAMC3_( const double* a, const double* b ); double dlamc3( const double* a, const double* b ); double dlamc3_( const double* a, const double* b ); void DLAMC4( int* emin, const double* start, const int* base ); void DLAMC4_( int* emin, const double* start, const int* base ); void dlamc4( int* emin, const double* start, const int* base ); void dlamc4_( int* emin, const double* start, const int* base ); void DLAMC5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void DLAMC5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void dlamc5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void dlamc5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, double* rmax ); void DLAMRG( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); void DLAMRG_( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); void dlamrg( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); void dlamrg_( const int* n1, const int* n2, const double* a, const int* dtrd1, const int* dtrd2, int* index ); int DLANEG( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); int DLANEG_( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); int dlaneg( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); int dlaneg_( const int* n, const double* d, const double* lld, const double* sigma, const double* pivmin, const int* r ); double DLANGB( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double DLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double dlangb( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double dlangb_( const char* norm, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, double* work ); double DLANGE( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double DLANGE_( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlange( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlange_( const char* norm, const int* m, const int* n, const double* a, const int* lda, double* work ); double DLANGT( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double DLANGT_( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double dlangt( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double dlangt_( const char* norm, const int* n, const double* dl, const double* d, const double* du ); double DLANHS( const char* norm, const int* n, const double* a, const int* lda, double* work ); double DLANHS_( const char* norm, const int* n, const double* a, const int* lda, double* work ); double dlanhs( const char* norm, const int* n, const double* a, const int* lda, double* work ); double dlanhs_( const char* norm, const int* n, const double* a, const int* lda, double* work ); double DLANSB( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlansb( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlansb_( const char* norm, const char* uplo, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANSF( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double DLANSF_( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double dlansf( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double dlansf_( const char* norm, const char* transr, const char* uplo, const int* n, const double* a, double* work ); double DLANSP( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double DLANSP_( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double dlansp( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double dlansp_( const char* norm, const char* uplo, const int* n, const double* ap, double* work ); double DLANST( const char* norm, const int* n, const double* d, const double* e ); double DLANST_( const char* norm, const int* n, const double* d, const double* e ); double dlanst( const char* norm, const int* n, const double* d, const double* e ); double dlanst_( const char* norm, const int* n, const double* d, const double* e ); double DLANSY( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double DLANSY_( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double dlansy( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double dlansy_( const char* norm, const char* uplo, const int* n, const double* a, const int* lda, double* work ); double DLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double dlantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const double* ab, const int* ldab, double* work ); double DLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double DLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double dlantp( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double dlantp_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* work ); double DLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); double DLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); double dlantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const double* a, const int* lda, double* work ); void DLANV2( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void DLANV2_( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void dlanv2( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void dlanv2_( double* a, double* b, double* c, double* d, double* rt1r, double* rt1i, double* rt2r, double* rt2i, double* cs, double* sn ); void DLAPLL( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void DLAPLL_( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void dlapll( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void dlapll_( const int* n, double* x, const int* incx, double* y, const int* incy, double* ssmin ); void DLAPMT( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void DLAPMT_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmt( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); void dlapmt_( const int* forwrd, const int* m, const int* n, double* x, const int* ldx, int* k ); double DLAPY2( const double* x, const double* y ); double DLAPY2_( const double* x, const double* y ); double dlapy2( const double* x, const double* y ); double dlapy2_( const double* x, const double* y ); double DLAPY3( const double* x, const double* y, const double* z ); double DLAPY3_( const double* x, const double* y, const double* z ); double dlapy3( const double* x, const double* y, const double* z ); double dlapy3_( const double* x, const double* y, const double* z ); void DLAQGB( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQGB_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqgb( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqgb_( const int* m, const int* n, const int* kl, const int* ku, double* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQGE( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQGE_( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqge( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void dlaqge_( const int* m, const int* n, double* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void DLAQP2( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void DLAQP2_( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void dlaqp2( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void dlaqp2_( const int* m, const int* n, const int* offset, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* work ); void DLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void DLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void dlaqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void dlaqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, double* a, const int* lda, int* jpvt, double* tau, double* vn1, double* vn2, double* auxv, double* f, const int* ldf ); void DLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR1( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void DLAQR1_( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void dlaqr1( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void dlaqr1_( const int* n, const double* h, const int* ldh, const double* sr1, double* si1, double* sr2, double* si2, double* v ); void DLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void dlaqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, int* ns, int* nd, double* sr, double* si, double* v, const int* ldv, const int* nh, double* t, const int* ldt, const int* nv, double* wv, const int* ldwv, double* work, const int* lwork ); void DLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dlaqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, double* h, const int* ldh, double* wr, double* wi, const int* iloz, const int* ihiz, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void DLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void dlaqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void dlaqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, double* sr, double* si, double* h, const int* ldh, const int* iloz, const int* ihiz, double* z, const int* ldz, double* v, const int* ldv, double* u, const int* ldu, const int* nv, double* wv, const int* ldwv, const int* nh, double* wh, const int* ldwh ); void DLAQSB( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSB_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsb( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsb_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSP( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSP_( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsp( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsp_( const char* uplo, const int* n, double* ap, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSY( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void DLAQSY_( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsy( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void dlaqsy_( const char* uplo, const int* n, double* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void DLAQTR( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void DLAQTR_( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void dlaqtr( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void dlaqtr_( const int* ltran, const int* lreal, const int* n, const double* t, const int* ldt, const double* b, const double* w, double* scale, double* x, double* work, int* info ); void DLAR1V( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void DLAR1V_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void dlar1v( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void dlar1v_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, double* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void DLAR2V( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void DLAR2V_( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void dlar2v( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void dlar2v_( const int* n, double* x, double* y, double* z, const int* incx, const double* c, const double* s, const int* incc ); void DLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARF( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARF_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarf( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarf_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARFG( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFG_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfg( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfg_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFGP( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFGP_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfgp( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfgp_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFP( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFP_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfp( const int* n, double* alpha, double* x, const int* incx, double* tau ); void dlarfp_( const int* n, double* alpha, double* x, const int* incx, double* tau ); void DLARFT( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLARFT_( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarft( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarft_( const char* direct, const char* storev, const int* n, const int* k, const double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLARFX( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void DLARFX_( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void dlarfx( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void dlarfx_( const char* side, const int* m, const int* n, const double* v, const double* tau, double* c, const int* ldc, double* work ); void DLARGV( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void DLARGV_( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void dlargv( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void dlargv_( const int* n, double* x, const int* incx, double* y, const int* incy, double* c, const int* incc ); void DLARNV( const int* idist, int* iseed, const int* n, double* x ); void DLARNV_( const int* idist, int* iseed, const int* n, double* x ); void dlarnv( const int* idist, int* iseed, const int* n, double* x ); void dlarnv_( const int* idist, int* iseed, const int* n, double* x ); void DLARRA( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void DLARRA_( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void dlarra( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void dlarra_( const int* n, const double* d, double* e, double* e2, const double* spltol, const double* tnrm, int* nsplit, int* isplit, int* info ); void DLARRB( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void DLARRB_( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void dlarrb( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void dlarrb_( const int* n, const double* d, const double* lld, const int* ifirst, const int* ilast, const double* rtol1, const double* rtol2, const int* offset, double* w, double* wgap, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, const int* twist, int* info ); void DLARRC( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void DLARRC_( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void dlarrc( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void dlarrc_( const char* jobt, const int* n, const double* vl, const double* vu, const double* d, const double* e, const double* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void DLARRD( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void DLARRD_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void dlarrd( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void dlarrd_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* gers, const double* reltol, const double* d, const double* e, const double* e2, const double* pivmin, const int* nsplit, const int* isplit, int* m, double* w, double* werr, double* wl, double* wu, int* iblock, int* indexw, double* work, int* iwork, int* info ); void DLARRE( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void DLARRE_( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void dlarre( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void dlarre_( const char* range, const int* n, double* vl, double* vu, const int* il, const int* iu, double* d, double* e, double* e2, const double* rtol1, const double* rtol2, const double* spltol, int* nsplit, int* isplit, int* m, double* w, double* werr, double* wgap, int* iblock, int* indexw, double* gers, double* pivmin, double* work, int* iwork, int* info ); void DLARRF( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void DLARRF_( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void dlarrf( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void dlarrf_( const int* n, const double* d, const double* l, const double* ld, const int* clstrt, const int* clend, const double* w, double* wgap, const double* werr, const double* spdiam, const double* clgapl, double* clgapr, const double* pivmin, double* sigma, double* dplus, double* lplus, double* work, int* info ); void DLARRJ( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void DLARRJ_( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void dlarrj( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void dlarrj_( const int* n, const double* d, const double* e2, const int* ifirst, const int* ilast, const double* rtol, const int* offset, double* w, double* werr, double* work, int* iwork, const double* pivmin, const double* spdiam, int* info ); void DLARRK( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void DLARRK_( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void dlarrk( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void dlarrk_( const int* n, const int* iw, const double* gl, const double* gu, const double* d, const double* e2, const double* pivmin, const double* reltol, double* w, double* werr, int* info ); void DLARRR( const int* n, const double* d, double* e, int* info ); void DLARRR_( const int* n, const double* d, double* e, int* info ); void dlarrr( const int* n, const double* d, double* e, int* info ); void dlarrr_( const int* n, const double* d, double* e, int* info ); void DLARRV( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void DLARRV_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void dlarrv( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void dlarrv_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, double* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void DLARSCL2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLARSCL2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlarscl2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlarscl2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLARTG( const double* f, const double* g, double* cs, double* sn, double* r ); void DLARTG_( const double* f, const double* g, double* cs, double* sn, double* r ); void dlartg( const double* f, const double* g, double* cs, double* sn, double* r ); void dlartg_( const double* f, const double* g, double* cs, double* sn, double* r ); void DLARTV( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void DLARTV_( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void dlartv( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void dlartv_( const int* n, double* x, const int* incx, double* y, const int* incy, const double* c, const double* s, const int* incc ); void DLARUV( int* iseed, const int* n, double* x ); void DLARUV_( int* iseed, const int* n, double* x ); void dlaruv( int* iseed, const int* n, double* x ); void dlaruv_( int* iseed, const int* n, double* x ); void DLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void dlarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* c, const int* ldc, double* work, const int* ldwork ); void DLARZ( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARZ_( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarz( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void dlarz_( const char* side, const int* m, const int* n, const int* l, const double* v, const int* incv, const double* tau, double* c, const int* ldc, double* work ); void DLARZT( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLARZT_( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarzt( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void dlarzt_( const char* direct, const char* storev, const int* n, const int* k, double* v, const int* ldv, const double* tau, double* t, const int* ldt ); void DLAS2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void DLAS2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void dlas2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void dlas2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax ); void DLASCL( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void DLASCL_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void dlascl( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void dlascl_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, double* a, const int* lda, int* info ); void DLASCL2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLASCL2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlascl2( const int* m, const int* n, const double* d, double* x, const int* ldx ); void dlascl2_( const int* m, const int* n, const double* d, double* x, const int* ldx ); void DLASD0( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void DLASD0_( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void dlasd0( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void dlasd0_( const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, const int* ldvt, const int* smlsiz, int* iwork, double* work, int* info ); void DLASD1( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void DLASD1_( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void dlasd1( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void dlasd1_( const int* nl, const int* nr, const int* sqre, double* d, double* alpha, double* beta, double* u, const int* ldu, double* vt, const int* ldvt, int* idxq, int* iwork, double* work, int* info ); void DLASD2( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void DLASD2_( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void dlasd2( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void dlasd2_( const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, const double* alpha, const double* beta, double* u, const int* ldu, double* vt, const int* ldvt, double* dsigma, double* u2, const int* ldu2, double* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void DLASD3( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void DLASD3_( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void dlasd3( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void dlasd3_( const int* nl, const int* nr, const int* sqre, const int* k, double* d, double* q, const int* ldq, const double* dsigma, double* u, const int* ldu, double* u2, const int* ldu2, double* vt, const int* ldvt, double* vt2, const int* ldvt2, const int* idxc, const int* ctot, const double* z, int* info ); void DLASD4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void DLASD4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void dlasd4( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void dlasd4_( const int* n, const int* i, const double* d, const double* z, double* delta, const double* rho, double* sigma, double* work, int* info ); void DLASD5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void DLASD5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void dlasd5( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void dlasd5_( const int* i, const double* d, const double* z, double* delta, const double* rho, double* dsigma, double* work ); void DLASD6( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void DLASD6_( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void dlasd6( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void dlasd6_( const int* icompq, const int* nl, const int* nr, const int* sqre, double* d, double* vf, double* vl, double* alpha, double* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* poles, double* difl, double* difr, double* z, int* k, double* c, double* s, double* work, int* iwork, int* info ); void DLASD7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void DLASD7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void dlasd7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void dlasd7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, double* d, double* z, double* zw, double* vf, double* vfw, double* vl, double* vlw, const double* alpha, const double* beta, double* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, double* givnum, const int* ldgnum, double* c, double* s, int* info ); void DLASD8( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void DLASD8_( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void dlasd8( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void dlasd8_( const int* icompq, const int* k, double* d, double* z, double* vf, double* vl, double* difl, double* difr, const int* lddifr, double* dsigma, double* work, int* info ); void DLASDA( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void DLASDA_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void dlasda( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void dlasda_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, double* d, const double* e, double* u, const int* ldu, double* vt, int* k, double* difl, double* difr, double* z, double* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, double* givnum, double* c, double* s, double* work, int* iwork, int* info ); void DLASDQ( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DLASDQ_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dlasdq( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void dlasdq_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, double* vt, const int* ldvt, double* u, const int* ldu, double* c, const int* ldc, double* work, int* info ); void DLASDT( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void DLASDT_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void dlasdt( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void dlasdt_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void DLASET( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void DLASET_( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void dlaset( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void dlaset_( const char* uplo, const int* m, const int* n, const double* alpha, const double* beta, double* a, const int* lda ); void DLASQ1( const int* n, double* d, double* e, double* work, int* info ); void DLASQ1_( const int* n, double* d, double* e, double* work, int* info ); void dlasq1( const int* n, double* d, double* e, double* work, int* info ); void dlasq1_( const int* n, double* d, double* e, double* work, int* info ); void DLASQ2( const int* n, double* z, int* info ); void DLASQ2_( const int* n, double* z, int* info ); void dlasq2( const int* n, double* z, int* info ); void dlasq2_( const int* n, double* z, int* info ); void DLASQ3( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void DLASQ3_( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void dlasq3( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void dlasq3_( const int* i0, const int* n0, const double* z, int* pp, double* dmin, double* sigma, double* desig, const double* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, double* dmin1, double* dmin2, double* dn, double* dn1, double* dn2, double* g, double* tau ); void DLASQ4( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void DLASQ4_( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void dlasq4( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void dlasq4_( const int* i0, const int* n0, const double* z, const int* pp, int* n0in, const double* dmin, const double* dmin1, const double* dmin2, const double* dn, const double* dn1, const double* dn2, double* tau, int* ttype, double* g ); void DLASQ5( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void DLASQ5_( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void dlasq5( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void dlasq5_( const int* i0, const int* n0, const double* z, const int* pp, const double* tau, const double* sigma, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2, const int* ieee, const double* eps); void DLASQ6( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void DLASQ6_( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void dlasq6( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void dlasq6_( const int* i0, const int* n0, const double* z, const int* pp, double* dmin, double* dmin1, double* dmin2, double* dn, double* dnm1, double* dnm2 ); void DLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void DLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void dlasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void dlasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, double* a, const int* lda ); void DLASRT( const char* id, const int* n, double* d, int* info ); void DLASRT_( const char* id, const int* n, double* d, int* info ); void dlasrt( const char* id, const int* n, double* d, int* info ); void dlasrt_( const char* id, const int* n, double* d, int* info ); void DLASSQ( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void DLASSQ_( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void dlassq( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void dlassq_( const int* n, const double* x, const int* incx, double* scale, double* sumsq ); void DLASV2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void DLASV2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void dlasv2( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void dlasv2_( const double* f, const double* g, const double* h, double* ssmin, double* ssmax, double* snr, double* csr, double* snl, double* csl ); void DLASWP( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void DLASWP_( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void dlaswp( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void dlaswp_( const int* n, double* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void DLASY2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void DLASY2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void dlasy2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void dlasy2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const double* tl, const int* ldtl, const double* tr, const int* ldtr, const double* b, const int* ldb, double* scale, double* x, const int* ldx, double* xnorm, int* info ); void DLASYF( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DLASYF_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void dlasyf_( const char* uplo, const int* n, const int* nb, int* kb, double* a, const int* lda, int* ipiv, double* w, const int* ldw, int* info ); void DLAT2S( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLAT2S_( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlat2s( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void dlat2s_( const char* uplo, const int* n, const double* a, const int* lda, float* sa, const int* ldsa, int* info ); void DLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void DLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void dlatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void dlatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const double* ab, const int* ldab, double* x, double* scale, double* cnorm, int* info ); void DLATDF( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void DLATDF_( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void dlatdf( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void dlatdf_( const int* ijob, const int* n, const double* z, const int* ldz, double* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void DLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void DLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void dlatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void dlatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* ap, double* x, double* scale, double* cnorm, int* info ); void DLATRD( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void DLATRD_( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void dlatrd( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void dlatrd_( const char* uplo, const int* n, const int* nb, double* a, const int* lda, double* e, double* tau, double* w, const int* ldw ); void DLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void DLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void dlatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void dlatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const double* a, const int* lda, double* x, double* scale, double* cnorm, int* info ); void DLATRZ( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void DLATRZ_( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void dlatrz( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void dlatrz_( const int* m, const int* n, const int* l, double* a, const int* lda, double* tau, double* work ); void DLATZM( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void DLATZM_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void dlatzm( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void dlatzm_( const char* side, const int* m, const int* n, const double* v, const int* incv, const double* tau, double* c1, double* c2, const int* ldc, double* work ); void DLAUU2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DLAUU2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauu2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauu2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DLAUUM( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DLAUUM_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauum( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dlauum_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DOPGTR( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void DOPGTR_( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void dopgtr( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void dopgtr_( const char* uplo, const int* n, const double* ap, const double* tau, double* q, const int* ldq, double* work, int* info ); void DOPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void DOPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void dopmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void dopmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* ap, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORG2L( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORG2L_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2l( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2l_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORG2R( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORG2R_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2r( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorg2r_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGBR( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGBR_( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgbr( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgbr_( const char* vect, const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGHR( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGHR_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorghr( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorghr_( const int* n, const int* ilo, const int* ihi, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGL2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGL2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgl2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgl2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGLQ( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGLQ_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorglq( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorglq_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQL( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQL_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgql( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgql_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQR( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGQR_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgqr( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgqr_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGR2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGR2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgr2( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void dorgr2_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, int* info ); void DORGRQ( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGRQ_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgrq( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgrq_( const int* m, const int* n, const int* k, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGTR( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORGTR_( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgtr( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void dorgtr_( const char* uplo, const int* n, double* a, const int* lda, const double* tau, double* work, const int* lwork, int* info ); void DORM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dorml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormql( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void dormr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, int* info ); void DORMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DORMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void dormtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const double* a, const int* lda, const double* tau, double* c, const int* ldc, double* work, const int* lwork, int* info ); void DPBCON( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPBCON_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpbcon( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpbcon_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPBEQU( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void DPBEQU_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void dpbequ( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void dpbequ_( const char* uplo, const int* n, const int* kd, const double* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void DPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBSTF( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBSTF_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbstf( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbstf_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, double* ab, const int* ldab, double* afb, const int* ldafb, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPBTF2( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTF2_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtf2( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtf2_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTRF( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTRF_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtrf( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void dpbtrf_( const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, int* info ); void DPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dpbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DPFTRF( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRF_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftrf( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftrf_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRI( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRI_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftri( const char* transr, const char* uplo, const int* n, double* a, int* info ); void dpftri_( const char* transr, const char* uplo, const int* n, double* a, int* info ); void DPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void DPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void dpftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void dpftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const double* a, double* b, const int* ldb, int* info ); void DPOCON( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPOCON_( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpocon( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dpocon_( const char* uplo, const int* n, const double* a, const int* lda, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPOEQUB( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPOEQUB_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequb( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequb_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPOEQU( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPOEQU_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequ( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void dpoequ_( const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, int* info ); void DPORFS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPORFS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dporfs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dporfs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPOSV( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void DPOSV_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void dposv( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void dposv_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* b, const int* ldb, int* info ); void DPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DPOTF2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTF2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotf2( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotf2_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRF( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRF_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotrf_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRI( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRI_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotri( const char* uplo, const int* n, double* a, const int* lda, int* info ); void dpotri_( const char* uplo, const int* n, double* a, const int* lda, int* info ); void DPOTRS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DPOTRS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dpotrs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dpotrs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DPPCON( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPPCON_( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dppcon( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dppcon_( const char* uplo, const int* n, const double* ap, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DPPEQU( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void DPPEQU_( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void dppequ( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void dppequ_( const char* uplo, const int* n, const double* ap, double* s, double* scond, double* amax, int* info ); void DPPRFS( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPRFS_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpprfs( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dpprfs_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPSV( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void DPPSV_( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void dppsv( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void dppsv_( const char* uplo, const int* n, const int* nrhs, double* ap, double* b, const int* ldb, int* info ); void DPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, double* ap, double* afp, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DPPTRF( const char* uplo, const int* n, double* ap, int* info ); void DPPTRF_( const char* uplo, const int* n, double* ap, int* info ); void dpptrf( const char* uplo, const int* n, double* ap, int* info ); void dpptrf_( const char* uplo, const int* n, double* ap, int* info ); void DPPTRI( const char* uplo, const int* n, double* ap, int* info ); void DPPTRI_( const char* uplo, const int* n, double* ap, int* info ); void dpptri( const char* uplo, const int* n, double* ap, int* info ); void dpptri_( const char* uplo, const int* n, double* ap, int* info ); void DPPTRS( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DPPTRS_( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dpptrs( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dpptrs_( const char* uplo, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DPSTF2( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPSTF2_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstf2( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstf2_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPSTRF( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPSTRF_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstrf( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void dpstrf_( const char* uplo, const int* n, double* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void DPTCON( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void DPTCON_( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void dptcon( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void dptcon_( const int* n, const double* d, const double* e, const double* anorm, double* rcond, double* work, int* info ); void DPTEQR( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DPTEQR_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dpteqr( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dpteqr_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DPTRFS( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void DPTRFS_( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void dptrfs( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void dptrfs_( const int* n, const int* nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* info ); void DPTSV( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void DPTSV_( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void dptsv( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void dptsv_( const int* n, const int* nrhs, double* d, double* e, double* b, const int* ldb, int* info ); void DPTSVX( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void DPTSVX_( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void dptsvx( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void dptsvx_( const char* fact, const int* n, const int* nrhs, const double* d, const double* e, double* df, double* ef, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* info ); void DPTTRF( const int* n, double* d, double* e, int* info ); void DPTTRF_( const int* n, double* d, double* e, int* info ); void dpttrf( const int* n, double* d, double* e, int* info ); void dpttrf_( const int* n, double* d, double* e, int* info ); void DPTTRS( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void DPTTRS_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void dpttrs( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void dpttrs_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb, int* info ); void DPTTS2( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void DPTTS2_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void dptts2( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void dptts2_( const int* n, const int* nrhs, const double* d, const double* e, double* b, const int* ldb ); void DRSCL( const int* n, const double* sa, double* sx, const int* incx ); void DRSCL_( const int* n, const double* sa, double* sx, const int* incx ); void drscl( const int* n, const double* sa, double* sx, const int* incx ); void drscl_( const int* n, const double* sa, double* sx, const int* incx ); void DSBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBEV( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void DSBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void dsbev( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void dsbev_( const char* jobz, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* w, double* z, const int* ldz, double* work, int* info ); void DSBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void DSBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void dsbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void dsbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, const double* bb, const int* ldbb, double* x, const int* ldx, double* work, int* info ); void DSBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void DSBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void dsbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void dsbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* w, double* z, const int* ldz, double* work, int* info ); void DSBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dsbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, double* ab, const int* ldab, double* bb, const int* ldbb, double* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSBTRD( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); void DSBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); void dsbtrd( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); void dsbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, double* ab, const int* ldab, double* d, double* e, double* q, const int* ldq, double* work, int* info ); double DSECND( void ); double DSECND_( void ); double dsecnd( void ); double dsecnd_( void ); void DSFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void DSFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void dsfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void dsfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const double* a, const int* lda, const double* beta, double* c ); void DSGESV( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSGESV_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsgesv( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsgesv_( const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSPCON( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSPCON_( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dspcon( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dspcon_( const char* uplo, const int* n, const double* ap, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSPEVD( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPEVD_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspevd( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspevd_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPEV( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void DSPEV_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void dspev( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void dspev_( const char* jobz, const char* uplo, const int* n, double* ap, double* w, double* z, const int* ldz, double* work, int* info ); void DSPEVX( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspevx( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspevx_( const char* jobz, const char* range, const char* uplo, const int* n, double* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPGST( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void DSPGST_( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void dspgst( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void dspgst_( const int* itype, const char* uplo, const int* n, double* ap, const double* bp, int* info ); void DSPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspgvd( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dspgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSPGV( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void DSPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void dspgv( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void dspgv_( const int* itype, const char* jobz, const char* uplo, const int* n, double* ap, double* bp, double* w, double* z, const int* ldz, double* work, int* info ); void DSPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dspgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* ap, double* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSPOSV( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSPOSV_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsposv( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void dsposv_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, const double* b, const int* ldb, double* x, const int* ldx, double* work, float* swork, int* iter, int* info ); void DSPRFS( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPRFS_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsprfs( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsprfs_( const char* uplo, const int* n, const int* nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPSV( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void DSPSV_( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void dspsv( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void dspsv_( const char* uplo, const int* n, const int* nrhs, double* ap, int* ipiv, double* b, const int* ldb, int* info ); void DSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void dspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* ap, double* afp, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSPTRD( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void DSPTRD_( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void dsptrd( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void dsptrd_( const char* uplo, const int* n, double* ap, double* d, double* e, double* tau, int* info ); void DSPTRF( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void DSPTRF_( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void dsptrf( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void dsptrf_( const char* uplo, const int* n, double* ap, int* ipiv, int* info ); void DSPTRI( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void DSPTRI_( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void dsptri( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void dsptri_( const char* uplo, const int* n, double* ap, const int* ipiv, double* work, int* info ); void DSPTRS( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void DSPTRS_( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void dsptrs( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void dsptrs_( const char* uplo, const int* n, const int* nrhs, const double* ap, const int* ipiv, double* b, const int* ldb, int* info ); void DSTEBZ( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void DSTEBZ_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void dstebz( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void dstebz_( const char* range, const char* order, const int* n, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork, int* info ); void DSTEDC( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEDC_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstedc( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstedc_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEGR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEGR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstegr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstegr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEIN( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSTEIN_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstein( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstein_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSTEMR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEMR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstemr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstemr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, double* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEQR( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTEQR_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dsteqr( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dsteqr_( const char* compz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTERF( const int* n, double* d, double* e, int* info ); void DSTERF_( const int* n, double* d, double* e, int* info ); void dsterf( const int* n, double* d, double* e, int* info ); void dsterf_( const int* n, double* d, double* e, int* info ); void DSTEVD( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEVD_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevd( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevd_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEV( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTEV_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dstev( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void dstev_( const char* jobz, const int* n, double* d, double* e, double* z, const int* ldz, double* work, int* info ); void DSTEVR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEVR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dstevr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSTEVX( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSTEVX_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstevx( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void dstevx_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void DSYCON( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYCON_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void dsycon_( const char* uplo, const int* n, const double* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, double* work, int* iwork, int* info ); void DSYEQUB( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void DSYEQUB_( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void dsyequb( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void dsyequb_( char* uplo, const int* n, const double* a, const int* lda, double* s, double* scond, double* amax, double* work, int* info ); void DSYEVD( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVD_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevd_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEV( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEV_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void dsyev_( const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* w, double* work, const int* lwork, int* info ); void DSYEVR( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVR_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsyevr_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYEVX( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYEVX_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsyevx_( const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYGS2( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGS2_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygs2( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygs2_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGST( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGST_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygst( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void dsygst_( const int* itype, const char* uplo, const int* n, double* a, const int* lda, const double* b, const int* ldb, int* info ); void DSYGVD( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsygvd( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dsygvd_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DSYGV( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYGV_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void dsygv_( const int* itype, const char* jobz, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, double* w, double* work, const int* lwork, int* info ); void DSYGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsygvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void dsygvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, double* a, const int* lda, double* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, double* z, const int* ldz, double* work, const int* lwork, int* iwork, int* ifail, int* info ); void DSYRFS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSYRFS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsyrfs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dsyrfs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const double* s, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYSV( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSV_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void dsysv_( const char* uplo, const int* n, const int* nrhs, double* a, const int* lda, int* ipiv, double* b, const int* ldb, double* work, const int* lwork, int* info ); void DSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void DSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void dsysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void dsysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, double* af, const int* ldaf, int* ipiv, const double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* ferr, double* berr, double* work, const int* lwork, int* iwork, int* info ); void DSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void dsysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, double* a, const int* lda, double* af, const int* ldaf, int* ipiv, char* equed, double* s, double* b, const int* ldb, double* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, double* work, int* iwork, int* info ); void DSYTD2( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void DSYTD2_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void dsytd2( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void dsytd2_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, int* info ); void DSYTF2( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTF2_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void dsytf2_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, int* info ); void DSYTRD( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void DSYTRD_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void dsytrd( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void dsytrd_( const char* uplo, const int* n, double* a, const int* lda, double* d, double* e, double* tau, double* work, const int* lwork, int* info ); void DSYTRF( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRF_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void dsytrf_( const char* uplo, const int* n, double* a, const int* lda, int* ipiv, double* work, const int* lwork, int* info ); void DSYTRI( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRI_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void dsytri_( const char* uplo, const int* n, double* a, const int* lda, const int* ipiv, double* work, int* info ); void DSYTRS( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DSYTRS_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void dsytrs_( const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const int* ipiv, double* b, const int* ldb, int* info ); void DTBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void DTBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void dtbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void dtbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const double* ab, const int* ldab, double* rcond, double* work, int* iwork, int* info ); void DTBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DTBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dtbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void dtbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const double* ab, const int* ldab, double* b, const int* ldb, int* info ); void DTFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void DTFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void dtfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void dtfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const double* alpha, const double* a, double* b, const int* ldb ); void DTFTRI( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void DTFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void dtftri( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void dtftri_( const char* transr, const char* uplo, const char* diag, const int* n, double* a, int* info ); void DTFTTP( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void DTFTTP_( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void dtfttp( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void dtfttp_( const char* transr, const char* uplo, const int* n, const double* arf, double* ap, int* info ); void DTFTTR( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void DTFTTR_( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void dtfttr( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void dtfttr_( const char* transr, const char* uplo, const int* n, const double* arf, double* a, const int* lda, int* info ); void DTGEVC( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTGEVC_( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtgevc( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtgevc_( const char* side, const char* howmny, const int* select, const int* n, const double* s, const int* lds, const double* p, const int* ldp, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTGEX2( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void DTGEX2_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void dtgex2( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void dtgex2_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, const int* j1, const int* n1, const int* n2, double* work, const int* lwork, int* info ); void DTGEXC( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void DTGEXC_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void dtgexc( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void dtgexc_( const int* wantq, const int* wantz, const int* n, double* a, const int* lda, double* b, const int* ldb, double* q, const int* ldq, double* z, const int* ldz, int* ifst, int* ilst, double* work, const int* lwork, int* info ); void DTGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, double* a, const int* lda, double* b, const int* ldb, double* alphar, double* alphai, double* beta, double* q, const int* ldq, double* z, const int* ldz, int* m, double* pl, double* pr, double* dif, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void DTGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void dtgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void dtgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, double* a, const int* lda, double* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, double* u, const int* ldu, double* v, const int* ldv, double* q, const int* ldq, double* work, int* ncycle, int* info ); void DTGSNA( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void DTGSNA_( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void dtgsna( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void dtgsna_( const char* job, const char* howmny, const int* select, const int* n, const double* a, const int* lda, const double* b, const int* ldb, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, double* work, const int* lwork, int* iwork, int* info ); void DTGSY2( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void DTGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void dtgsy2( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void dtgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* iwork, int* pq, int* info ); void DTGSYL( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void DTGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void dtgsyl( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void dtgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, const double* d, const int* ldd, const double* e, const int* lde, double* f, const int* ldf, double* scale, double* dif, double* work, const int* lwork, int* iwork, int* info ); void DTPCON( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void DTPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void dtpcon( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void dtpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const double* ap, double* rcond, double* work, int* iwork, int* info ); void DTPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTPTRI( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void DTPTRI_( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void dtptri( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void dtptri_( const char* uplo, const char* diag, const int* n, double* ap, int* info ); void DTPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DTPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dtptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void dtptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* ap, double* b, const int* ldb, int* info ); void DTPTTF( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void DTPTTF_( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void dtpttf( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void dtpttf_( const char* transr, const char* uplo, const int* n, const double* ap, double* arf, int* info ); void DTPTTR( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void DTPTTR_( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void dtpttr( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void dtpttr_( const char* uplo, const int* n, const double* ap, double* a, const int* lda, int* info ); void DTRCON( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void DTRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void dtrcon( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void dtrcon_( const char* norm, const char* uplo, const char* diag, const int* n, const double* a, const int* lda, double* rcond, double* work, int* iwork, int* info ); void DTREVC( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTREVC_( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtrevc( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void dtrevc_( const char* side, const char* howmny, int* select, const int* n, const double* t, const int* ldt, double* vl, const int* ldvl, double* vr, const int* ldvr, const int* mm, int* m, double* work, int* info ); void DTREXC( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void DTREXC_( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void dtrexc( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void dtrexc_( const char* compq, const int* n, double* t, const int* ldt, double* q, const int* ldq, int* ifst, int* ilst, double* work, int* info ); void DTRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtrrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void dtrrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, const double* b, const int* ldb, const double* x, const int* ldx, double* ferr, double* berr, double* work, int* iwork, int* info ); void DTRSEN( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTRSEN_( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtrsen( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void dtrsen_( const char* job, const char* compq, const int* select, const int* n, double* t, const int* ldt, double* q, const int* ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void DTRSNA( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void DTRSNA_( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void dtrsna( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void dtrsna_( const char* job, const char* howmny, const int* select, const int* n, const double* t, const int* ldt, const double* vl, const int* ldvl, const double* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, double* work, const int* ldwork, int* iwork, int* info ); void DTRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void DTRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void dtrsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void dtrsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const double* a, const int* lda, const double* b, const int* ldb, double* c, const int* ldc, double* scale, int* info ); void DTRTI2( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTI2_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrti2( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrti2_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTRI( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTRI_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrtri( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void dtrtri_( const char* uplo, const char* diag, const int* n, double* a, const int* lda, int* info ); void DTRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DTRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dtrtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void dtrtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const double* a, const int* lda, double* b, const int* ldb, int* info ); void DTRTTF( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void DTRTTF_( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void dtrttf( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void dtrttf_( const char* transr, const char* uplo, const int* n, const double* a, const int* lda, double* arf, int* info ); void DTRTTP( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void DTRTTP_( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void dtrttp( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void dtrttp_( const char* uplo, const int* n, const double* a, const int* lda, double* ap, int* info ); void DTZRQF( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void DTZRQF_( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void dtzrqf( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void dtzrqf_( const int* m, const int* n, double* a, const int* lda, double* tau, int* info ); void DTZRZF( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void DTZRZF_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dtzrzf( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); void dtzrzf_( const int* m, const int* n, double* a, const int* lda, double* tau, double* work, const int* lwork, int* info ); double DZSUM1( const int* n, const MKL_Complex16* cx, const int* incx ); double DZSUM1_( const int* n, const MKL_Complex16* cx, const int* incx ); double dzsum1( const int* n, const MKL_Complex16* cx, const int* incx ); double dzsum1_( const int* n, const MKL_Complex16* cx, const int* incx ); int ICMAX1( const int* n, const MKL_Complex8* cx, const int* incx ); int ICMAX1_( const int* n, const MKL_Complex8* cx, const int* incx ); int icmax1( const int* n, const MKL_Complex8* cx, const int* incx ); int icmax1_( const int* n, const MKL_Complex8* cx, const int* incx ); int IEEECK( const int* ispec, const float* zero, const float* one ); int IEEECK_( const int* ispec, const float* zero, const float* one ); int ieeeck( const int* ispec, const float* zero, const float* one ); int ieeeck_( const int* ispec, const float* zero, const float* one ); int ILACLC( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILACLC_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclc( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclc_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILACLR( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILACLR_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclr( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ilaclr_( const int* m, const int* n, const MKL_Complex8* a, const int* lda ); int ILADIAG( const char* diag ); int ILADIAG_( const char* diag ); int iladiag( const char* diag ); int iladiag_( const char* diag ); int ILADLC( const int* m, const int* n, const double* a, const int* lda ); int ILADLC_( const int* m, const int* n, const double* a, const int* lda ); int iladlc( const int* m, const int* n, const double* a, const int* lda ); int iladlc_( const int* m, const int* n, const double* a, const int* lda ); int ILADLR( const int* m, const int* n, const double* a, const int* lda ); int ILADLR_( const int* m, const int* n, const double* a, const int* lda ); int iladlr( const int* m, const int* n, const double* a, const int* lda ); int iladlr_( const int* m, const int* n, const double* a, const int* lda ); int ILAENV( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ILAENV_( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ilaenv( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ilaenv_( const int* ispec, const char* name, const char* opts, const int* n1, const int* n2, const int* n3, const int* n4 ); int ILAPREC( const char* prec ); int ILAPREC_( const char* prec ); int ilaprec( const char* prec ); int ilaprec_( const char* prec ); int ILASLC( const int* m, const int* n, const float* a, const int* lda ); int ILASLC_( const int* m, const int* n, const float* a, const int* lda ); int ilaslc( const int* m, const int* n, const float* a, const int* lda ); int ilaslc_( const int* m, const int* n, const float* a, const int* lda ); int ILASLR( const int* m, const int* n, const float* a, const int* lda ); int ILASLR_( const int* m, const int* n, const float* a, const int* lda ); int ilaslr( const int* m, const int* n, const float* a, const int* lda ); int ilaslr_( const int* m, const int* n, const float* a, const int* lda ); int ILATRANS( const char* trans ); int ILATRANS_( const char* trans ); int ilatrans( const char* trans ); int ilatrans_( const char* trans ); int ILAUPLO( const char* uplo ); int ILAUPLO_( const char* uplo ); int ilauplo( const char* uplo ); int ilauplo_( const char* uplo ); void ILAVER( int* vers_major, int* vers_minor, int* vers_patch ); void ILAVER_( int* vers_major, int* vers_minor, int* vers_patch ); void ilaver( int* vers_major, int* vers_minor, int* vers_patch ); void ilaver_( int* vers_major, int* vers_minor, int* vers_patch ); int ILAZLC( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ILAZLC_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlc( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlc_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ILAZLR( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ILAZLR_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlr( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int ilazlr_( const int* m, const int* n, const MKL_Complex16* a, const int* lda ); int IPARMQ( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int IPARMQ_( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int iparmq( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int iparmq_( const int* ispec, const char* name, const char* opts, const int* n, const int* ilo, const int* ihi, const int* lwork ); int IZMAX1( const int* n, const MKL_Complex16* cx, const int* incx ); int IZMAX1_( const int* n, const MKL_Complex16* cx, const int* incx ); int izmax1( const int* n, const MKL_Complex16* cx, const int* incx ); int izmax1_( const int* n, const MKL_Complex16* cx, const int* incx ); int LSAMEN( const int* n, const char* ca, const char* cb ); int LSAMEN_( const int* n, const char* ca, const char* cb ); int lsamen( const int* n, const char* ca, const char* cb ); int lsamen_( const int* n, const char* ca, const char* cb ); void SBDSDC( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void SBDSDC_( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void sbdsdc( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void sbdsdc_( const char* uplo, const char* compq, const int* n, float* d, float* e, float* u, const int* ldu, float* vt, const int* ldvt, float* q, int* iq, float* work, int* iwork, int* info ); void SBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void SBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void sbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void sbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); float SCSUM1( const int* n, const MKL_Complex8* cx, const int* incx ); float SCSUM1_( const int* n, const MKL_Complex8* cx, const int* incx ); float scsum1( const int* n, const MKL_Complex8* cx, const int* incx ); float scsum1_( const int* n, const MKL_Complex8* cx, const int* incx ); void SDISNA( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); void SDISNA_( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); void sdisna( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); void sdisna_( const char* job, const int* m, const int* n, const float* d, float* sep, int* info ); float SECOND( void ); float SECOND_( void ); float second( void ); float second_( void ); void SGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void SGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void sgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void sgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* pt, const int* ldpt, float* c, const int* ldc, float* work, int* info ); void SGBCON( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgbcon( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequb( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequb_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBEQU( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequ( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgbequ_( const int* m, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void SGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void sgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void sgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, int* ipiv, float* b, const int* ldb, int* info ); void SGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGBTF2( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTF2_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtf2( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtf2_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTRF( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTRF_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtrf( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void sgbtrf_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, int* ipiv, int* info ); void SGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void SGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void sgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void sgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const int* ipiv, float* b, const int* ldb, int* info ); void SGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void SGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void sgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void sgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* scale, const int* m, float* v, const int* ldv, int* info ); void SGEBAL( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void SGEBAL_( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void sgebal( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void sgebal_( const char* job, const int* n, float* a, const int* lda, int* ilo, int* ihi, float* scale, int* info ); void SGEBD2( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void SGEBD2_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void sgebd2( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void sgebd2_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, int* info ); void SGEBRD( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void SGEBRD_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void sgebrd( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void sgebrd_( const int* m, const int* n, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* work, const int* lwork, int* info ); void SGECON( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGECON_( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgecon( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgecon_( const char* norm, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGEEQUB( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEEQUB_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequb( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequb_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEEQU( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEEQU_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequ( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void sgeequ_( const int* m, const int* n, const float* a, const int* lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax, int* info ); void SGEES( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void SGEES_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void sgees( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void sgees_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* work, const int* lwork, int* bwork, int* info ); void SGEESX( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGEESX_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sgeesx( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sgeesx_( const char* jobvs, const char* sort, MKL_S_SELECT_FUNCTION_2 select, const char* sense, const int* n, float* a, const int* lda, int* sdim, float* wr, float* wi, float* vs, const int* ldvs, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGEEV( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEEV_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgeev( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgeev_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void SGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void sgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void sgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* wr, float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* info ); void SGEGS( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void SGEGS_( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void sgegs( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void sgegs_( const char* jobvsl, const char* jobvsr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* info ); void SGEGV( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEGV_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgegv( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sgegv_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGEHD2( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void SGEHD2_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void sgehd2( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void sgehd2_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, int* info ); void SGEHRD( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEHRD_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgehrd( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgehrd_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEJSV( const char* joba, char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void SGEJSV_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void sgejsv( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void sgejsv_( const char* joba, const char* jobu, const char* jobv, const char* jobr, const char* jobt, const char* jobp, const int* m, const int* n, float* a, const int* lda, float* sva, float* u, const int* ldu, float* v, const int* ldv, float* work, const int* lwork, int* iwork, int* info ); void SGELQ2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGELQ2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgelq2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgelq2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGELQF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGELQF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgelqf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgelqf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGELSD( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void SGELSD_( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void sgelsd( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void sgelsd_( const int* m, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* iwork, int* info ); void SGELS( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SGELS_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgels( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void sgels_( const char* trans, const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SGELSS( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGELSS_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelss( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelss_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, float* s, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGELSX( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void SGELSX_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void sgelsx( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void sgelsx_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, int* info ); void SGELSY( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGELSY_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelsy( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void sgelsy_( const int* m, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* jpvt, const float* rcond, int* rank, float* work, const int* lwork, int* info ); void SGEQL2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQL2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeql2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeql2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQLF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQLF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqlf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqlf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQP3( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void SGEQP3_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void sgeqp3( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void sgeqp3_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, const int* lwork, int* info ); void SGEQPF( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void SGEQPF_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void sgeqpf( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void sgeqpf_( const int* m, const int* n, float* a, const int* lda, int* jpvt, float* tau, float* work, int* info ); void SGEQR2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQR2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQR2P( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQR2P_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2p( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgeqr2p_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGEQRF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQRF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQRFP( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGEQRFP_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrfp( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgeqrfp_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGERFS( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGERFS_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgerfs( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgerfs_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* r, const float* c, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGERQ2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGERQ2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgerq2( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void sgerq2_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, int* info ); void SGERQF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGERQF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgerqf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void sgerqf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void SGESC2( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void SGESC2_( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void sgesc2( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void sgesc2_( const int* n, const float* a, const int* lda, float* rhs, const int* ipiv, const int* jpiv, float* scale ); void SGESDD( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void SGESDD_( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesdd( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void sgesdd_( const char* jobz, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* iwork, int* info ); void SGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void SGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void sgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void sgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, float* a, const int* lda, float* s, float* u, const int* ldu, float* vt, const int* ldvt, float* work, const int* lwork, int* info ); void SGESV( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void SGESV_( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void sgesv( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void sgesv_( const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, int* info ); void SGESVJ( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void SGESVJ_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void sgesvj( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void sgesvj_( const char* joba, const char* jobu, const char* jobv, const int* m, const int* n, float* a, const int* lda, float* sva, const int* mv, float* v, const int* ldv, float* work, const int* lwork, int* info ); void SGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* r, float* c, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SGETC2( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void SGETC2_( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void sgetc2( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void sgetc2_( const int* n, float* a, const int* lda, int* ipiv, int* jpiv, int* info ); void SGETF2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETF2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetf2( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetf2_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETRF( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SGETRF_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void sgetrf_( const int* m, const int* n, float* a, const int* lda, int* ipiv, int* info ); void MKL_SGETRFNPI( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void MKL_SGETRFNPI_( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void mkl_sgetrfnpi( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void mkl_sgetrfnpi_( const int* m, const int* n, const int* nfact, float* a, const int* lda, int* info ); void SGETRI( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void SGETRI_( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void sgetri( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void sgetri_( const int* n, float* a, const int* lda, const int* ipiv, float* work, const int* lwork, int* info ); void SGETRS( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SGETRS_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void sgetrs( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void sgetrs_( const char* trans, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void SGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void sggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void sggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const float* lscale, const float* rscale, const int* m, float* v, const int* ldv, int* info ); void SGGBAL( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void SGGBAL_( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void sggbal( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void sggbal_( const char* job, const int* n, float* a, const int* lda, float* b, const int* ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work, int* info ); void SGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void SGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void sgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* work, const int* lwork, int* bwork, int* info ); void SGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void sggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_S_SELECT_FUNCTION_3 selctg, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, const int* ldvsl, float* vsr, const int* ldvsr, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, const int* liwork, int* bwork, int* info ); void SGGEV( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGGEV_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void sggev_( const char* jobvl, const char* jobvr, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, float* work, const int* lwork, int* info ); void SGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void SGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void sggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void sggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* vl, const int* ldvl, float* vr, const int* ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, const int* lwork, int* iwork, int* bwork, int* info ); void SGGGLM( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void SGGGLM_( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void sggglm( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void sggglm_( const int* n, const int* m, const int* p, float* a, const int* lda, float* b, const int* ldb, float* d, float* x, float* y, float* work, const int* lwork, int* info ); void SGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void SGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void sgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void sgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* info ); void SGGLSE( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void SGGLSE_( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void sgglse( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void sgglse_( const int* m, const int* n, const int* p, float* a, const int* lda, float* b, const int* ldb, float* c, float* d, float* x, float* work, const int* lwork, int* info ); void SGGQRF( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGQRF_( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggqrf( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggqrf_( const int* n, const int* m, const int* p, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGRQF( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGRQF_( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggrqf( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void sggrqf_( const int* m, const int* p, const int* n, float* a, const int* lda, float* taua, float* b, const int* ldb, float* taub, float* work, const int* lwork, int* info ); void SGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void SGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void sggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void sggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, float* a, const int* lda, float* b, const int* ldb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* iwork, int* info ); void SGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void SGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void sggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void sggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, int* k, int* l, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, int* iwork, float* tau, float* work, int* info ); void SGSVJ0( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGSVJ0_( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj0( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj0_( const char* jobv, const int* m, const int* n, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGSVJ1( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGSVJ1_( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj1( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void sgsvj1_( const char* jobv, const int* m, const int* n, const int* n1, float* a, const int* lda, float* d, float* sva, const int* mv, float* v, const int* ldv, const float* eps, const float* sfmin, const float* tol, const int* nsweep, float* work, const int* lwork, int* info ); void SGTCON( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGTCON_( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgtcon( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sgtcon_( const char* norm, const int* n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SGTRFS( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTRFS_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtrfs( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtrfs_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTSV( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void SGTSV_( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void sgtsv( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void sgtsv_( const int* n, const int* nrhs, float* dl, float* d, float* du, float* b, const int* ldb, int* info ); void SGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SGTTRF( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void SGTTRF_( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void sgttrf( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void sgttrf_( const int* n, float* dl, float* d, float* du, float* du2, int* ipiv, int* info ); void SGTTRS( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void SGTTRS_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void sgttrs( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void sgttrs_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb, int* info ); void SGTTS2( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void SGTTS2_( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void sgtts2( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void sgtts2_( const int* itrans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, const int* ldb ); void SHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* t, const int* ldt, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SHSEIN( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void SHSEIN_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void shsein( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void shsein_( const char* side, const char* eigsrc, const char* initv, int* select, const int* n, const float* h, const int* ldh, float* wr, const float* wi, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* ifaill, int* ifailr, int* info ); void SHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); void shseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, float* z, const int* ldz, float* work, const int* lwork, int* info ); int SISNAN( const float* sin ); int SISNAN_( const float* sin ); int sisnan( const float* sin ); int sisnan_( const float* sin ); void SLABAD( float* smallx, float* large ); void SLABAD_( float* smallx, float* large ); void slabad( float* smallx, float* large ); void slabad_( float* smallx, float* large ); void SLABRD( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void SLABRD_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void slabrd( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void slabrd_( const int* m, const int* n, const int* nb, float* a, const int* lda, float* d, float* e, float* tauq, float* taup, float* x, const int* ldx, float* y, const int* ldy ); void SLACN2( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void SLACN2_( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void slacn2( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void slacn2_( const int* n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); void SLACON( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void SLACON_( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void slacon( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void slacon_( const int* n, float* v, float* x, int* isgn, float* est, int* kase ); void SLACPY( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void SLACPY_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void slacpy( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void slacpy_( const char* uplo, const int* m, const int* n, const float* a, const int* lda, float* b, const int* ldb ); void SLADIV( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void SLADIV_( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void sladiv( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void sladiv_( const float* a, const float* b, const float* c, const float* d, float* p, float* q ); void SLAE2( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void SLAE2_( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void slae2( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void slae2_( const float* a, const float* b, const float* c, float* rt1, float* rt2 ); void SLAEBZ( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void SLAEBZ_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void slaebz( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void slaebz_( const int* ijob, const int* nitmax, const int* n, const int* mmax, const int* minp, const int* nbmin, const float* abstol, const float* reltol, const float* pivmin, const float* d, const float* e, const float* e2, int* nval, float* ab, float* c, int* mout, int* nab, float* work, int* iwork, int* info ); void SLAED0( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void SLAED0_( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void slaed0( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void slaed0_( const int* icompq, const int* qsiz, const int* n, float* d, const float* e, float* q, const int* ldq, float* qstore, const int* ldqs, float* work, int* iwork, int* info ); void SLAED1( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void SLAED1_( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void slaed1( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void slaed1_( const int* n, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* work, int* iwork, int* info ); void SLAED2( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void SLAED2_( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void slaed2( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void slaed2_( int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, int* indxq, float* rho, const float* z, float* dlamda, float* w, float* q2, int* indx, int* indxc, int* indxp, int* coltyp, int* info ); void SLAED3( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void SLAED3_( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void slaed3( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void slaed3_( const int* k, const int* n, const int* n1, float* d, float* q, const int* ldq, const float* rho, float* dlamda, const float* q2, const int* indx, const int* ctot, float* w, float* s, int* info ); void SLAED4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void SLAED4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void slaed4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void slaed4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam, int* info ); void SLAED5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void SLAED5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void slaed5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void slaed5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dlam ); void SLAED6( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void SLAED6_( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void slaed6( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void slaed6_( const int* kniter, const int* orgati, const float* rho, const float* d, const float* z, const float* finit, float* tau, int* info ); void SLAED7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void SLAED7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void slaed7( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void slaed7_( const int* icompq, const int* n, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, float* d, float* q, const int* ldq, int* indxq, const float* rho, const int* cutpnt, float* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, float* work, int* iwork, int* info ); void SLAED8( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void SLAED8_( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void slaed8( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void slaed8_( const int* icompq, int* k, const int* n, const int* qsiz, float* d, float* q, const int* ldq, const int* indxq, float* rho, const int* cutpnt, const float* z, float* dlamda, float* q2, const int* ldq2, float* w, int* perm, int* givptr, int* givcol, float* givnum, int* indxp, int* indx, int* info ); void SLAED9( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void SLAED9_( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void slaed9( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void slaed9_( const int* k, const int* kstart, const int* kstop, const int* n, float* d, float* q, const int* ldq, const float* rho, const float* dlamda, const float* w, float* s, const int* lds, int* info ); void SLAEDA( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void SLAEDA_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void slaeda( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void slaeda_( const int* n, const int* tlvls, const int* curlvl, const int* curpbm, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const float* givnum, const float* q, const int* qptr, float* z, float* ztemp, int* info ); void SLAEIN( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void SLAEIN_( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void slaein( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void slaein_( const int* rightv, const int* noinit, const int* n, const float* h, const int* ldh, const float* wr, const float* wi, float* vr, float* vi, float* b, const int* ldb, float* work, const float* eps3, const float* smlnum, const float* bignum, int* info ); void SLAEV2( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void SLAEV2_( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void slaev2( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void slaev2_( const float* a, const float* b, const float* c, float* rt1, float* rt2, float* cs1, float* sn1 ); void SLAEXC( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void SLAEXC_( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void slaexc( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void slaexc_( const int* wantq, const int* n, float* t, const int* ldt, float* q, const int* ldq, const int* j1, const int* n1, const int* n2, float* work, int* info ); void SLAG2D( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void SLAG2D_( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void slag2d( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void slag2d_( const int* m, const int* n, const float* sa, const int* ldsa, double* a, const int* lda, int* info ); void SLAG2( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void SLAG2_( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void slag2( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void slag2_( const float* a, const int* lda, const float* b, const int* ldb, const float* safmin, float* scale1, float* scale2, float* wr1, float* wr2, float* wi ); void SLAGS2( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void SLAGS2_( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void slags2( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void slags2_( const int* upper, const float* a1, const float* a2, const float* a3, const float* b1, const float* b2, const float* b3, float* csu, float* snu, float* csv, float* snv, float* csq, float* snq ); void SLAGTF( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void SLAGTF_( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void slagtf( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void slagtf_( const int* n, float* a, const float* lambda, float* b, float* c, const float* tol, float* d, int* in, int* info ); void SLAGTM( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void SLAGTM_( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void slagtm( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void slagtm_( const char* trans, const int* n, const int* nrhs, const float* alpha, const float* dl, const float* d, const float* du, const float* x, const int* ldx, const float* beta, float* b, const int* ldb ); void SLAGTS( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void SLAGTS_( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void slagts( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void slagts_( const int* job, const int* n, const float* a, const float* b, const float* c, const float* d, const int* in, float* y, float* tol, int* info ); void SLAGV2( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void SLAGV2_( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void slagv2( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void slagv2_( float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* csl, float* snl, float* csr, float* snr ); void SLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void SLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void slahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void slahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, int* info ); void SLAHR2( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAHR2_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahr2( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahr2_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAHRD( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAHRD_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahrd( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void slahrd_( const int* n, const int* k, const int* nb, float* a, const int* lda, float* tau, float* t, const int* ldt, float* y, const int* ldy ); void SLAIC1( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); void SLAIC1_( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); void slaic1( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); void slaic1_( const int* job, const int* j, const float* x, const float* sest, const float* w, const float* gamma, float* sestpr, float* s, float* c ); int SLAISNAN( const float* sin1, const float* sin2 ); int SLAISNAN_( const float* sin1, const float* sin2 ); int slaisnan( const float* sin1, const float* sin2 ); int slaisnan_( const float* sin1, const float* sin2 ); void SLALN2( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void SLALN2_( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void slaln2( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void slaln2_( const int* ltrans, const int* na, const int* nw, const float* smin, const float* ca, const float* a, const int* lda, const float* d1, const float* d2, const float* b, const int* ldb, const float* wr, const float* wi, float* x, const int* ldx, float* scale, float* xnorm, int* info ); void SLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void SLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void slals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void slals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const float* givnum, const int* ldgnum, const float* poles, const float* difl, const float* difr, const float* z, const int* k, const float* c, const float* s, float* work, int* info ); void SLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void SLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void slalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void slalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, float* b, const int* ldb, float* bx, const int* ldbx, const float* u, const int* ldu, const float* vt, const int* k, const float* difl, const float* difr, const float* z, const float* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const float* givnum, const float* c, const float* s, float* work, int* iwork, int* info ); void SLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); void SLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); void slalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); void slalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, const float* rcond, int* rank, float* work, int* iwork, int* info ); float SLAMCH( const char* cmach ); float SLAMCH_( const char* cmach ); float slamch( const char* cmach ); float slamch_( const char* cmach ); void SLAMC1( int* beta, int* t, int* rnd, int* ieee1 ); void SLAMC1_( int* beta, int* t, int* rnd, int* ieee1 ); void slamc1( int* beta, int* t, int* rnd, int* ieee1 ); void slamc1_( int* beta, int* t, int* rnd, int* ieee1 ); void SLAMC2( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); void SLAMC2_( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); void slamc2( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); void slamc2_( int* beta, int* t, int* rnd, float* eps, int* emin, float* rmin, int* emax, float* rmax ); float SLAMC3( const float* a, const float* b ); float SLAMC3_( const float* a, const float* b ); float slamc3( const float* a, const float* b ); float slamc3_( const float* a, const float* b ); void SLAMC4( int* emin, const float* start, const int* base ); void SLAMC4_( int* emin, const float* start, const int* base ); void slamc4( int* emin, const float* start, const int* base ); void slamc4_( int* emin, const float* start, const int* base ); void SLAMC5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void SLAMC5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void slamc5( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void slamc5_( const int* beta, const int* p, const int* emin, const int* ieee, int* emax, float* rmax ); void SLAMRG( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); void SLAMRG_( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); void slamrg( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); void slamrg_( const int* n1, const int* n2, const float* a, const int* strd1, const int* strd2, int* index ); int SLANEG( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); int SLANEG_( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); int slaneg( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); int slaneg_( const int* n, const float* d, const float* lld, const float* sigma, const float* pivmin, const int* r ); float SLANGB( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float SLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float slangb( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float slangb_( const char* norm, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, float* work ); float SLANGE( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float SLANGE_( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float slange( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float slange_( const char* norm, const int* m, const int* n, const float* a, const int* lda, float* work ); float SLANGT( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float SLANGT_( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float slangt( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float slangt_( const char* norm, const int* n, const float* dl, const float* d, const float* du ); float SLANHS( const char* norm, const int* n, const float* a, const int* lda, float* work ); float SLANHS_( const char* norm, const int* n, const float* a, const int* lda, float* work ); float slanhs( const char* norm, const int* n, const float* a, const int* lda, float* work ); float slanhs_( const char* norm, const int* n, const float* a, const int* lda, float* work ); float SLANSB( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slansb( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slansb_( const char* norm, const char* uplo, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANSF( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float SLANSF_( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float slansf( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float slansf_( const char* norm, const char* transr, const char* uplo, const int* n, const float* a, float* work ); float SLANSP( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float SLANSP_( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float slansp( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float slansp_( const char* norm, const char* uplo, const int* n, const float* ap, float* work ); float SLANST( const char* norm, const int* n, const float* d, const float* e ); float SLANST_( const char* norm, const int* n, const float* d, const float* e ); float slanst( const char* norm, const int* n, const float* d, const float* e ); float slanst_( const char* norm, const int* n, const float* d, const float* e ); float SLANSY( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float SLANSY_( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float slansy( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float slansy_( const char* norm, const char* uplo, const int* n, const float* a, const int* lda, float* work ); float SLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float slantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const float* ab, const int* ldab, float* work ); float SLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float SLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float slantp( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float slantp_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* work ); float SLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); float SLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); float slantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); float slantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const float* a, const int* lda, float* work ); void SLANV2( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void SLANV2_( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void slanv2( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void slanv2_( float* a, float* b, float* c, float* d, float* rt1r, float* rt1i, float* rt2r, float* rt2i, float* cs, float* sn ); void SLAPLL( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void SLAPLL_( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void slapll( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void slapll_( const int* n, float* x, const int* incx, float* y, const int* incy, float* ssmin ); void SLAPMT( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void SLAPMT_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmt( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); void slapmt_( const int* forwrd, const int* m, const int* n, float* x, const int* ldx, int* k ); float SLAPY2( const float* x, const float* y ); float SLAPY2_( const float* x, const float* y ); float slapy2( const float* x, const float* y ); float slapy2_( const float* x, const float* y ); float SLAPY3( const float* x, const float* y, const float* z ); float SLAPY3_( const float* x, const float* y, const float* z ); float slapy3( const float* x, const float* y, const float* z ); float slapy3_( const float* x, const float* y, const float* z ); void SLAQGB( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQGB_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqgb( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqgb_( const int* m, const int* n, const int* kl, const int* ku, float* ab, const int* ldab, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQGE( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQGE_( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqge( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void slaqge_( const int* m, const int* n, float* a, const int* lda, const float* r, const float* c, const float* rowcnd, const float* colcnd, const float* amax, char* equed ); void SLAQP2( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void SLAQP2_( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void slaqp2( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void slaqp2_( const int* m, const int* n, const int* offset, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* work ); void SLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void SLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void slaqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void slaqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, float* a, const int* lda, int* jpvt, float* tau, float* vn1, float* vn2, float* auxv, float* f, const int* ldf ); void SLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR1( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void SLAQR1_( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void slaqr1( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void slaqr1_( const int* n, const float* h, const int* ldh, const float* sr1, float* si1, float* sr2, float* si2, float* v ); void SLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void slaqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, int* ns, int* nd, float* sr, float* si, float* v, const int* ldv, const int* nh, float* t, const int* ldt, const int* nv, float* wv, const int* ldwv, float* work, const int* lwork ); void SLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void slaqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, float* h, const int* ldh, float* wr, float* wi, const int* iloz, const int* ihiz, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void SLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void slaqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void slaqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, float* sr, float* si, float* h, const int* ldh, const int* iloz, const int* ihiz, float* z, const int* ldz, float* v, const int* ldv, float* u, const int* ldu, const int* nv, float* wv, const int* ldwv, const int* nh, float* wh, const int* ldwh ); void SLAQSB( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSB_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void slaqsb( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void slaqsb_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSP( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSP_( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void slaqsp( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void slaqsp_( const char* uplo, const int* n, float* ap, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSY( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void SLAQSY_( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void slaqsy( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void slaqsy_( const char* uplo, const int* n, float* a, const int* lda, const float* s, const float* scond, const float* amax, char* equed ); void SLAQTR( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void SLAQTR_( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void slaqtr( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void slaqtr_( const int* ltran, const int* lreal, const int* n, const float* t, const int* ldt, const float* b, const float* w, float* scale, float* x, float* work, int* info ); void SLAR1V( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void SLAR1V_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void slar1v( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void slar1v_( const int* n, const int* b1, const int* bn, const float* lambda, const float* d, const float* l, const float* ld, const float* lld, const float* pivmin, const float* gaptol, float* z, const int* wantnc, int* negcnt, float* ztz, float* mingma, int* r, int* isuppz, float* nrminv, float* resid, float* rqcorr, float* work ); void SLAR2V( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void SLAR2V_( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void slar2v( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void slar2v_( const int* n, float* x, float* y, float* z, const int* incx, const float* c, const float* s, const int* incc ); void SLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARF( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARF_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarf( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarf_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARFG( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFG_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfg( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfg_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFGP( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFGP_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfgp( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfgp_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFP( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFP_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfp( const int* n, float* alpha, float* x, const int* incx, float* tau ); void slarfp_( const int* n, float* alpha, float* x, const int* incx, float* tau ); void SLARFT( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLARFT_( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarft( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarft_( const char* direct, const char* storev, const int* n, const int* k, const float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLARFX( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void SLARFX_( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void slarfx( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void slarfx_( const char* side, const int* m, const int* n, const float* v, const float* tau, float* c, const int* ldc, float* work ); void SLARGV( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void SLARGV_( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void slargv( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void slargv_( const int* n, float* x, const int* incx, float* y, const int* incy, float* c, const int* incc ); void SLARNV( const int* idist, int* iseed, const int* n, float* x ); void SLARNV_( const int* idist, int* iseed, const int* n, float* x ); void slarnv( const int* idist, int* iseed, const int* n, float* x ); void slarnv_( const int* idist, int* iseed, const int* n, float* x ); void SLARRA( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void SLARRA_( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void slarra( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void slarra_( const int* n, const float* d, float* e, float* e2, const float* spltol, const float* tnrm, int* nsplit, int* isplit, int* info ); void SLARRB( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void SLARRB_( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void slarrb( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void slarrb_( const int* n, const float* d, const float* lld, const int* ifirst, const int* ilast, const float* rtol1, const float* rtol2, const int* offset, float* w, float* wgap, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, const int* twist, int* info ); void SLARRC( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void SLARRC_( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void slarrc( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void slarrc_( const char* jobt, const int* n, const float* vl, const float* vu, const float* d, const float* e, const float* pivmin, int* eigcnt, int* lcnt, int* rcnt, int* info ); void SLARRD( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void SLARRD_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void slarrd( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void slarrd_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* gers, const float* reltol, const float* d, const float* e, const float* e2, const float* pivmin, const int* nsplit, const int* isplit, int* m, float* w, float* werr, float* wl, float* wu, int* iblock, int* indexw, float* work, int* iwork, int* info ); void SLARRE( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void SLARRE_( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void slarre( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void slarre_( const char* range, const int* n, float* vl, float* vu, const int* il, const int* iu, float* d, float* e, float* e2, const float* rtol1, const float* rtol2, const float* spltol, int* nsplit, int* isplit, int* m, float* w, float* werr, float* wgap, int* iblock, int* indexw, float* gers, float* pivmin, float* work, int* iwork, int* info ); void SLARRF( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void SLARRF_( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void slarrf( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void slarrf_( const int* n, const float* d, const float* l, const float* ld, const int* clstrt, const int* clend, const float* w, float* wgap, const float* werr, const float* spdiam, const float* clgapl, float* clgapr, const float* pivmin, float* sigma, float* dplus, float* lplus, float* work, int* info ); void SLARRJ( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void SLARRJ_( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void slarrj( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void slarrj_( const int* n, const float* d, const float* e2, const int* ifirst, const int* ilast, const float* rtol, const int* offset, float* w, float* werr, float* work, int* iwork, const float* pivmin, const float* spdiam, int* info ); void SLARRK( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void SLARRK_( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void slarrk( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void slarrk_( const int* n, const int* iw, const float* gl, const float* gu, const float* d, const float* e2, const float* pivmin, const float* reltol, float* w, float* werr, int* info ); void SLARRR( const int* n, const float* d, float* e, int* info ); void SLARRR_( const int* n, const float* d, float* e, int* info ); void slarrr( const int* n, const float* d, float* e, int* info ); void slarrr_( const int* n, const float* d, float* e, int* info ); void SLARRV( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void SLARRV_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void slarrv( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void slarrv_( const int* n, const float* vl, const float* vu, float* d, float* l, float* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const float* minrgp, const float* rtol1, const float* rtol2, float* w, float* werr, float* wgap, const int* iblock, const int* indexw, const float* gers, float* z, const int* ldz, int* isuppz, float* work, int* iwork, int* info ); void SLARSCL2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLARSCL2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slarscl2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slarscl2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLARTG( const float* f, const float* g, float* cs, float* sn, float* r ); void SLARTG_( const float* f, const float* g, float* cs, float* sn, float* r ); void slartg( const float* f, const float* g, float* cs, float* sn, float* r ); void slartg_( const float* f, const float* g, float* cs, float* sn, float* r ); void SLARTV( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void SLARTV_( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void slartv( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void slartv_( const int* n, float* x, const int* incx, float* y, const int* incy, const float* c, const float* s, const int* incc ); void SLARUV( int* iseed, const int* n, float* x ); void SLARUV_( int* iseed, const int* n, float* x ); void slaruv( int* iseed, const int* n, float* x ); void slaruv_( int* iseed, const int* n, float* x ); void SLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void slarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* c, const int* ldc, float* work, const int* ldwork ); void SLARZ( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARZ_( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarz( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void slarz_( const char* side, const int* m, const int* n, const int* l, const float* v, const int* incv, const float* tau, float* c, const int* ldc, float* work ); void SLARZT( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLARZT_( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarzt( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void slarzt_( const char* direct, const char* storev, const int* n, const int* k, float* v, const int* ldv, const float* tau, float* t, const int* ldt ); void SLAS2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void SLAS2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void slas2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void slas2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax ); void SLASCL( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void SLASCL_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void slascl( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void slascl_( const char* type, const int* kl, const int* ku, const float* cfrom, const float* cto, const int* m, const int* n, float* a, const int* lda, int* info ); void SLASCL2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLASCL2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slascl2( const int* m, const int* n, const float* d, float* x, const int* ldx ); void slascl2_( const int* m, const int* n, const float* d, float* x, const int* ldx ); void SLASD0( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void SLASD0_( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void slasd0( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void slasd0_( const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, const int* ldvt, const int* smlsiz, int* iwork, float* work, int* info ); void SLASD1( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void SLASD1_( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void slasd1( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void slasd1_( const int* nl, const int* nr, const int* sqre, float* d, float* alpha, float* beta, float* u, const int* ldu, float* vt, const int* ldvt, int* idxq, int* iwork, float* work, int* info ); void SLASD2( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void SLASD2_( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void slasd2( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void slasd2_( const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, const float* alpha, const float* beta, float* u, const int* ldu, float* vt, const int* ldvt, float* dsigma, float* u2, const int* ldu2, float* vt2, const int* ldvt2, int* idxp, int* idx, int* idxc, int* idxq, int* coltyp, int* info ); void SLASD3( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void SLASD3_( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void slasd3( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void slasd3_( const int* nl, const int* nr, const int* sqre, const int* k, float* d, float* q, const int* ldq, float* dsigma, float* u, const int* ldu, const float* u2, const int* ldu2, float* vt, const int* ldvt, float* vt2, const int* ldvt2, const int* idxc, const int* ctot, float* z, int* info ); void SLASD4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void SLASD4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void slasd4( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void slasd4_( const int* n, const int* i, const float* d, const float* z, float* delta, const float* rho, float* sigma, float* work, int* info ); void SLASD5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void SLASD5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void slasd5( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void slasd5_( const int* i, const float* d, const float* z, float* delta, const float* rho, float* dsigma, float* work ); void SLASD6( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void SLASD6_( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void slasd6( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void slasd6_( const int* icompq, const int* nl, const int* nr, const int* sqre, float* d, float* vf, float* vl, float* alpha, float* beta, int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* poles, float* difl, float* difr, float* z, int* k, float* c, float* s, float* work, int* iwork, int* info ); void SLASD7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void SLASD7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void slasd7( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void slasd7_( const int* icompq, const int* nl, const int* nr, const int* sqre, int* k, float* d, float* z, float* zw, float* vf, float* vfw, float* vl, float* vlw, const float* alpha, const float* beta, float* dsigma, int* idx, int* idxp, const int* idxq, int* perm, int* givptr, int* givcol, const int* ldgcol, float* givnum, const int* ldgnum, float* c, float* s, int* info ); void SLASD8( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void SLASD8_( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void slasd8( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void slasd8_( const int* icompq, const int* k, float* d, float* z, float* vf, float* vl, float* difl, float* difr, const int* lddifr, float* dsigma, float* work, int* info ); void SLASDA( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void SLASDA_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void slasda( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void slasda_( const int* icompq, const int* smlsiz, const int* n, const int* sqre, float* d, const float* e, float* u, const int* ldu, float* vt, int* k, float* difl, float* difr, float* z, float* poles, int* givptr, int* givcol, const int* ldgcol, int* perm, float* givnum, float* c, float* s, float* work, int* iwork, int* info ); void SLASDQ( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void SLASDQ_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void slasdq( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void slasdq_( const char* uplo, const int* sqre, const int* n, const int* ncvt, const int* nru, const int* ncc, float* d, float* e, float* vt, const int* ldvt, float* u, const int* ldu, float* c, const int* ldc, float* work, int* info ); void SLASDT( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void SLASDT_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void slasdt( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void slasdt_( const int* n, int* lvl, int* nd, int* inode, int* ndiml, int* ndimr, const int* msub ); void SLASET( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void SLASET_( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void slaset( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void slaset_( const char* uplo, const int* m, const int* n, const float* alpha, const float* beta, float* a, const int* lda ); void SLASQ1( const int* n, float* d, float* e, float* work, int* info ); void SLASQ1_( const int* n, float* d, float* e, float* work, int* info ); void slasq1( const int* n, float* d, float* e, float* work, int* info ); void slasq1_( const int* n, float* d, float* e, float* work, int* info ); void SLASQ2( const int* n, float* z, int* info ); void SLASQ2_( const int* n, float* z, int* info ); void slasq2( const int* n, float* z, int* info ); void slasq2_( const int* n, float* z, int* info ); void SLASQ3( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void SLASQ3_( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void slasq3( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void slasq3_( const int* i0, const int* n0, const float* z, int* pp, float* dmin, float* sigma, float* desig, const float* qmax, int* nfail, int* iter, int* ndiv, const int* ieee, int* ttype, float* dmin1, float* dmin2, float* dn, float* dn1, float* dn2, float* g, float* tau ); void SLASQ4( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void SLASQ4_( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void slasq4( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void slasq4_( const int* i0, const int* n0, const float* z, const int* pp, int* n0in, const float* dmin, const float* dmin1, const float* dmin2, const float* dn, const float* dn1, const float* dn2, float* tau, int* ttype, float* g ); void SLASQ5( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void SLASQ5_( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void slasq5( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void slasq5_( const int* i0, const int* n0, const float* z, const int* pp, const float* tau, const float* sigma, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2, const int* ieee, const float* eps ); void SLASQ6( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void SLASQ6_( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void slasq6( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void slasq6_( const int* i0, const int* n0, const float* z, const int* pp, float* dmin, float* dmin1, float* dmin2, float* dn, float* dnm1, float* dnm2 ); void SLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void SLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void slasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void slasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const float* c, const float* s, float* a, const int* lda ); void SLASRT( const char* id, const int* n, float* d, int* info ); void SLASRT_( const char* id, const int* n, float* d, int* info ); void slasrt( const char* id, const int* n, float* d, int* info ); void slasrt_( const char* id, const int* n, float* d, int* info ); void SLASSQ( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void SLASSQ_( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void slassq( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void slassq_( const int* n, const float* x, const int* incx, float* scale, float* sumsq ); void SLASV2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void SLASV2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void slasv2( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void slasv2_( const float* f, const float* g, const float* h, float* ssmin, float* ssmax, float* snr, float* csr, float* snl, float* csl ); void SLASWP( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void SLASWP_( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void slaswp( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void slaswp_( const int* n, float* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void SLASY2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void SLASY2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void slasy2( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void slasy2_( const int* ltranl, const int* ltranr, const int* isgn, const int* n1, const int* n2, const float* tl, const int* ldtl, const float* tr, const int* ldtr, const float* b, const int* ldb, float* scale, float* x, const int* ldx, float* xnorm, int* info ); void SLASYF( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SLASYF_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void slasyf_( const char* uplo, const int* n, const int* nb, int* kb, float* a, const int* lda, int* ipiv, float* w, const int* ldw, int* info ); void SLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void SLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void slatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void slatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const float* ab, const int* ldab, float* x, float* scale, float* cnorm, int* info ); void SLATDF( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void SLATDF_( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void slatdf( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void slatdf_( const int* ijob, const int* n, const float* z, const int* ldz, float* rhs, float* rdsum, float* rdscal, const int* ipiv, const int* jpiv ); void SLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void SLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void slatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void slatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* ap, float* x, float* scale, float* cnorm, int* info ); void SLATRD( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void SLATRD_( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void slatrd( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void slatrd_( const char* uplo, const int* n, const int* nb, float* a, const int* lda, float* e, float* tau, float* w, const int* ldw ); void SLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void SLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void slatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void slatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const float* a, const int* lda, float* x, float* scale, float* cnorm, int* info ); void SLATRZ( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void SLATRZ_( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void slatrz( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void slatrz_( const int* m, const int* n, const int* l, float* a, const int* lda, float* tau, float* work ); void SLATZM( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void SLATZM_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void slatzm( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void slatzm_( const char* side, const int* m, const int* n, const float* v, const int* incv, const float* tau, float* c1, float* c2, const int* ldc, float* work ); void SLAUU2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SLAUU2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauu2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauu2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SLAUUM( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SLAUUM_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauum( const char* uplo, const int* n, float* a, const int* lda, int* info ); void slauum_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SOPGTR( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void SOPGTR_( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void sopgtr( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void sopgtr_( const char* uplo, const int* n, const float* ap, const float* tau, float* q, const int* ldq, float* work, int* info ); void SOPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void SOPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void sopmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void sopmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* ap, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORG2L( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORG2L_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2l( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2l_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORG2R( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORG2R_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2r( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorg2r_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGBR( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGBR_( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgbr( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgbr_( const char* vect, const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGHR( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGHR_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorghr( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorghr_( const int* n, const int* ilo, const int* ihi, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGL2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGL2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgl2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgl2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGLQ( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGLQ_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorglq( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorglq_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQL( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQL_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgql( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgql_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQR( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGQR_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgqr( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgqr_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGR2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGR2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgr2( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void sorgr2_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, int* info ); void SORGRQ( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGRQ_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgrq( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgrq_( const int* m, const int* n, const int* k, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGTR( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORGTR_( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgtr( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void sorgtr_( const char* uplo, const int* n, float* a, const int* lda, const float* tau, float* work, const int* lwork, int* info ); void SORM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sorml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormql( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void sormr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, int* info ); void SORMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SORMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void sormtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const float* a, const int* lda, const float* tau, float* c, const int* ldc, float* work, const int* lwork, int* info ); void SPBCON( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPBCON_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spbcon( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spbcon_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPBEQU( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void SPBEQU_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void spbequ( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void spbequ_( const char* uplo, const int* n, const int* kd, const float* ab, const int* ldab, float* s, float* scond, float* amax, int* info ); void SPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBSTF( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBSTF_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbstf( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbstf_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void spbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, float* ab, const int* ldab, float* afb, const int* ldafb, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPBTF2( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTF2_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtf2( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtf2_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTRF( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTRF_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtrf( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void spbtrf_( const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, int* info ); void SPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void spbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void SPFTRF( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRF_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftrf( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftrf_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRI( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRI_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftri( const char* transr, const char* uplo, const int* n, float* a, int* info ); void spftri_( const char* transr, const char* uplo, const int* n, float* a, int* info ); void SPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void SPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void spftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void spftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const float* a, float* b, const int* ldb, int* info ); void SPOCON( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPOCON_( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spocon( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void spocon_( const char* uplo, const int* n, const float* a, const int* lda, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPOEQUB( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPOEQUB_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequb( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequb_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPOEQU( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPOEQU_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequ( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void spoequ_( const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, int* info ); void SPORFS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPORFS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sporfs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void sporfs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPOSV( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void SPOSV_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void sposv( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void sposv_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* b, const int* ldb, int* info ); void SPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void sposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SPOTF2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTF2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotf2( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotf2_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRF( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRF_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotrf_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRI( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRI_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotri( const char* uplo, const int* n, float* a, const int* lda, int* info ); void spotri_( const char* uplo, const int* n, float* a, const int* lda, int* info ); void SPOTRS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void SPOTRS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void spotrs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void spotrs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void SPPCON( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPPCON_( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sppcon( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sppcon_( const char* uplo, const int* n, const float* ap, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SPPEQU( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void SPPEQU_( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void sppequ( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void sppequ_( const char* uplo, const int* n, const float* ap, float* s, float* scond, float* amax, int* info ); void SPPRFS( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPRFS_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spprfs( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void spprfs_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPSV( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void SPPSV_( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void sppsv( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void sppsv_( const char* uplo, const int* n, const int* nrhs, float* ap, float* b, const int* ldb, int* info ); void SPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, float* ap, float* afp, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SPPTRF( const char* uplo, const int* n, float* ap, int* info ); void SPPTRF_( const char* uplo, const int* n, float* ap, int* info ); void spptrf( const char* uplo, const int* n, float* ap, int* info ); void spptrf_( const char* uplo, const int* n, float* ap, int* info ); void SPPTRI( const char* uplo, const int* n, float* ap, int* info ); void SPPTRI_( const char* uplo, const int* n, float* ap, int* info ); void spptri( const char* uplo, const int* n, float* ap, int* info ); void spptri_( const char* uplo, const int* n, float* ap, int* info ); void SPPTRS( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void SPPTRS_( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void spptrs( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void spptrs_( const char* uplo, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void SPSTF2( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPSTF2_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstf2( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstf2_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPSTRF( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPSTRF_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstrf( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void spstrf_( const char* uplo, const int* n, float* a, const int* lda, int* piv, int* rank, const float* tol, float* work, int* info ); void SPTCON( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void SPTCON_( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void sptcon( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void sptcon_( const int* n, const float* d, const float* e, const float* anorm, float* rcond, float* work, int* info ); void SPTEQR( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SPTEQR_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void spteqr( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void spteqr_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SPTRFS( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void SPTRFS_( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void sptrfs( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void sptrfs_( const int* n, const int* nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* info ); void SPTSV( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void SPTSV_( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void sptsv( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void sptsv_( const int* n, const int* nrhs, float* d, float* e, float* b, const int* ldb, int* info ); void SPTSVX( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void SPTSVX_( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void sptsvx( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void sptsvx_( const char* fact, const int* n, const int* nrhs, const float* d, const float* e, float* df, float* ef, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* info ); void SPTTRF( const int* n, float* d, float* e, int* info ); void SPTTRF_( const int* n, float* d, float* e, int* info ); void spttrf( const int* n, float* d, float* e, int* info ); void spttrf_( const int* n, float* d, float* e, int* info ); void SPTTRS( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void SPTTRS_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void spttrs( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void spttrs_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb, int* info ); void SPTTS2( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void SPTTS2_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void sptts2( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void sptts2_( const int* n, const int* nrhs, const float* d, const float* e, float* b, const int* ldb ); void SRSCL( const int* n, const float* sa, float* sx, const int* incx ); void SRSCL_( const int* n, const float* sa, float* sx, const int* incx ); void srscl( const int* n, const float* sa, float* sx, const int* incx ); void srscl_( const int* n, const float* sa, float* sx, const int* incx ); void SSBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBEV( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void SSBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void ssbev( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void ssbev_( const char* jobz, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* w, float* z, const int* ldz, float* work, int* info ); void SSBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void SSBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void ssbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void ssbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, const float* bb, const int* ldbb, float* x, const int* ldx, float* work, int* info ); void SSBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void SSBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void ssbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void ssbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* w, float* z, const int* ldz, float* work, int* info ); void SSBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void ssbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, float* ab, const int* ldab, float* bb, const int* ldbb, float* q, const int* ldq, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSBTRD( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void SSBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void ssbtrd( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void ssbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, float* ab, const int* ldab, float* d, float* e, float* q, const int* ldq, float* work, int* info ); void SSFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void SSFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void ssfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void ssfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const float* alpha, const float* a, const int* lda, const float* beta, float* c ); void SSPCON( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSPCON_( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sspcon( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void sspcon_( const char* uplo, const int* n, const float* ap, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSPEVD( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPEVD_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspevd( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspevd_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPEV( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void SSPEV_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void sspev( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void sspev_( const char* jobz, const char* uplo, const int* n, float* ap, float* w, float* z, const int* ldz, float* work, int* info ); void SSPEVX( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspevx( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspevx_( const char* jobz, const char* range, const char* uplo, const int* n, float* ap, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPGST( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void SSPGST_( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void sspgst( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void sspgst_( const int* itype, const char* uplo, const int* n, float* ap, const float* bp, int* info ); void SSPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspgvd( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sspgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSPGV( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void SSPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void sspgv( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void sspgv_( const int* itype, const char* jobz, const char* uplo, const int* n, float* ap, float* bp, float* w, float* z, const int* ldz, float* work, int* info ); void SSPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sspgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* ap, float* bp, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSPRFS( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPRFS_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssprfs( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssprfs_( const char* uplo, const int* n, const int* nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPSV( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void SSPSV_( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void sspsv( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void sspsv_( const char* uplo, const int* n, const int* nrhs, float* ap, int* ipiv, float* b, const int* ldb, int* info ); void SSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void sspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* ap, float* afp, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSPTRD( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void SSPTRD_( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void ssptrd( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void ssptrd_( const char* uplo, const int* n, float* ap, float* d, float* e, float* tau, int* info ); void SSPTRF( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void SSPTRF_( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void ssptrf( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void ssptrf_( const char* uplo, const int* n, float* ap, int* ipiv, int* info ); void SSPTRI( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void SSPTRI_( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void ssptri( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void ssptri_( const char* uplo, const int* n, float* ap, const int* ipiv, float* work, int* info ); void SSPTRS( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void SSPTRS_( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void ssptrs( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void ssptrs_( const char* uplo, const int* n, const int* nrhs, const float* ap, const int* ipiv, float* b, const int* ldb, int* info ); void SSTEBZ( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void SSTEBZ_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void sstebz( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void sstebz_( const char* range, const char* order, const int* n, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork, int* info ); void SSTEDC( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEDC_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstedc( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstedc_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEGR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEGR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstegr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstegr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEIN( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSTEIN_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstein( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstein_( const int* n, const float* d, const float* e, const int* m, const float* w, const int* iblock, const int* isplit, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSTEMR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEMR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstemr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstemr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, int* m, float* w, float* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEQR( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTEQR_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void ssteqr( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void ssteqr_( const char* compz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTERF( const int* n, float* d, float* e, int* info ); void SSTERF_( const int* n, float* d, float* e, int* info ); void ssterf( const int* n, float* d, float* e, int* info ); void ssterf_( const int* n, float* d, float* e, int* info ); void SSTEVD( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEVD_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevd( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevd_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEV( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTEV_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void sstev( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void sstev_( const char* jobz, const int* n, float* d, float* e, float* z, const int* ldz, float* work, int* info ); void SSTEVR( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEVR_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevr( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void sstevr_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSTEVX( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSTEVX_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstevx( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void sstevx_( const char* jobz, const char* range, const int* n, float* d, float* e, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, int* iwork, int* ifail, int* info ); void SSYCON( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYCON_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void ssycon_( const char* uplo, const int* n, const float* a, const int* lda, const int* ipiv, const float* anorm, float* rcond, float* work, int* iwork, int* info ); void SSYEQUB( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void SSYEQUB_( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void ssyequb( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void ssyequb_( char* uplo, const int* n, const float* a, const int* lda, float* s, float* scond, float* amax, float* work, int* info ); void SSYEVD( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVD_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevd_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEV( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEV_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void ssyev_( const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* w, float* work, const int* lwork, int* info ); void SSYEVR( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVR_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssyevr_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, int* isuppz, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYEVX( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYEVX_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssyevx_( const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYGS2( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGS2_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygs2( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygs2_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGST( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGST_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygst( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void ssygst_( const int* itype, const char* uplo, const int* n, float* a, const int* lda, const float* b, const int* ldb, int* info ); void SSYGVD( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssygvd( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ssygvd_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void SSYGV( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYGV_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void ssygv_( const int* itype, const char* jobz, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, float* w, float* work, const int* lwork, int* info ); void SSYGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssygvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void ssygvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, float* a, const int* lda, float* b, const int* ldb, const float* vl, const float* vu, const int* il, const int* iu, const float* abstol, int* m, float* w, float* z, const int* ldz, float* work, const int* lwork, int* iwork, int* ifail, int* info ); void SSYRFS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSYRFS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssyrfs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void ssyrfs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void SSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const float* s, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYSV( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSV_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void ssysv_( const char* uplo, const int* n, const int* nrhs, float* a, const int* lda, int* ipiv, float* b, const int* ldb, float* work, const int* lwork, int* info ); void SSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void SSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void ssysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void ssysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, float* af, const int* ldaf, int* ipiv, const float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* ferr, float* berr, float* work, const int* lwork, int* iwork, int* info ); void SSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void ssysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, float* a, const int* lda, float* af, const int* ldaf, int* ipiv, char* equed, float* s, float* b, const int* ldb, float* x, const int* ldx, float* rcond, float* rpvgrw, float* berr, const int* n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, const int* nparams, float* params, float* work, int* iwork, int* info ); void SSYTD2( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void SSYTD2_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void ssytd2( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void ssytd2_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, int* info ); void SSYTF2( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTF2_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void ssytf2_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, int* info ); void SSYTRD( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void SSYTRD_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void ssytrd( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void ssytrd_( const char* uplo, const int* n, float* a, const int* lda, float* d, float* e, float* tau, float* work, const int* lwork, int* info ); void SSYTRF( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRF_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void ssytrf_( const char* uplo, const int* n, float* a, const int* lda, int* ipiv, float* work, const int* lwork, int* info ); void SSYTRI( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRI_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void ssytri_( const char* uplo, const int* n, float* a, const int* lda, const int* ipiv, float* work, int* info ); void SSYTRS( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void SSYTRS_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void ssytrs_( const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const int* ipiv, float* b, const int* ldb, int* info ); void STBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void STBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void stbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void stbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const float* ab, const int* ldab, float* rcond, float* work, int* iwork, int* info ); void STBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void STBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void stbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void stbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const float* ab, const int* ldab, float* b, const int* ldb, int* info ); void STFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void STFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void stfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void stfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const float* alpha, const float* a, float* b, const int* ldb ); void STFTRI( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void STFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void stftri( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void stftri_( const char* transr, const char* uplo, const char* diag, const int* n, float* a, int* info ); void STFTTP( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void STFTTP_( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void stfttp( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void stfttp_( const char* transr, const char* uplo, const int* n, const float* arf, float* ap, int* info ); void STFTTR( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void STFTTR_( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void stfttr( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void stfttr_( const char* transr, const char* uplo, const int* n, const float* arf, float* a, const int* lda, int* info ); void STGEVC( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STGEVC_( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void stgevc( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void stgevc_( const char* side, const char* howmny, const int* select, const int* n, const float* s, const int* lds, const float* p, const int* ldp, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STGEX2( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void STGEX2_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void stgex2( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void stgex2_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, const int* j1, const int* n1, const int* n2, float* work, const int* lwork, int* info ); void STGEXC( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void STGEXC_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void stgexc( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void stgexc_( const int* wantq, const int* wantz, const int* n, float* a, const int* lda, float* b, const int* ldb, float* q, const int* ldq, float* z, const int* ldz, int* ifst, int* ilst, float* work, const int* lwork, int* info ); void STGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void stgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void stgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, float* a, const int* lda, float* b, const int* ldb, float* alphar, float* alphai, float* beta, float* q, const int* ldq, float* z, const int* ldz, int* m, float* pl, float* pr, float* dif, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void STGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void stgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void stgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, float* a, const int* lda, float* b, const int* ldb, const float* tola, const float* tolb, float* alpha, float* beta, float* u, const int* ldu, float* v, const int* ldv, float* q, const int* ldq, float* work, int* ncycle, int* info ); void STGSNA( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void STGSNA_( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void stgsna( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void stgsna_( const char* job, const char* howmny, const int* select, const int* n, const float* a, const int* lda, const float* b, const int* ldb, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* dif, const int* mm, int* m, float* work, const int* lwork, int* iwork, int* info ); void STGSY2( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void STGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void stgsy2( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void stgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* rdsum, float* rdscal, int* iwork, int* pq, int* info ); void STGSYL( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void STGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void stgsyl( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void stgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, const float* d, const int* ldd, const float* e, const int* lde, float* f, const int* ldf, float* scale, float* dif, float* work, const int* lwork, int* iwork, int* info ); void STPCON( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void STPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void stpcon( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void stpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const float* ap, float* rcond, float* work, int* iwork, int* info ); void STPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void stprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STPTRI( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void STPTRI_( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void stptri( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void stptri_( const char* uplo, const char* diag, const int* n, float* ap, int* info ); void STPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void STPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void stptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void stptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* ap, float* b, const int* ldb, int* info ); void STPTTF( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void STPTTF_( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void stpttf( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void stpttf_( const char* transr, const char* uplo, const int* n, const float* ap, float* arf, int* info ); void STPTTR( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void STPTTR_( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void stpttr( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void stpttr_( const char* uplo, const int* n, const float* ap, float* a, const int* lda, int* info ); void STRCON( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void STRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void strcon( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void strcon_( const char* norm, const char* uplo, const char* diag, const int* n, const float* a, const int* lda, float* rcond, float* work, int* iwork, int* info ); void STREVC( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STREVC_( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void strevc( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void strevc_( const char* side, const char* howmny, int* select, const int* n, const float* t, const int* ldt, float* vl, const int* ldvl, float* vr, const int* ldvr, const int* mm, int* m, float* work, int* info ); void STREXC( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void STREXC_( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void strexc( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void strexc_( const char* compq, const int* n, float* t, const int* ldt, float* q, const int* ldq, int* ifst, int* ilst, float* work, int* info ); void STRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void strrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void strrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, const float* b, const int* ldb, const float* x, const int* ldx, float* ferr, float* berr, float* work, int* iwork, int* info ); void STRSEN( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STRSEN_( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void strsen( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void strsen_( const char* job, const char* compq, const int* select, const int* n, float* t, const int* ldt, float* q, const int* ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, const int* lwork, int* iwork, const int* liwork, int* info ); void STRSNA( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void STRSNA_( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void strsna( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void strsna_( const char* job, const char* howmny, const int* select, const int* n, const float* t, const int* ldt, const float* vl, const int* ldvl, const float* vr, const int* ldvr, float* s, float* sep, const int* mm, int* m, float* work, const int* ldwork, int* iwork, int* info ); void STRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void STRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void strsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void strsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const float* a, const int* lda, const float* b, const int* ldb, float* c, const int* ldc, float* scale, int* info ); void STRTI2( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTI2_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strti2( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strti2_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTRI( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTRI_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strtri( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void strtri_( const char* uplo, const char* diag, const int* n, float* a, const int* lda, int* info ); void STRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void STRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void strtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void strtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const float* a, const int* lda, float* b, const int* ldb, int* info ); void STRTTF( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void STRTTF_( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void strttf( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void strttf_( const char* transr, const char* uplo, const int* n, const float* a, const int* lda, float* arf, int* info ); void STRTTP( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void STRTTP_( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void strttp( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void strttp_( const char* uplo, const int* n, const float* a, const int* lda, float* ap, int* info ); void STZRQF( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void STZRQF_( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void stzrqf( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void stzrqf_( const int* m, const int* n, float* a, const int* lda, float* tau, int* info ); void STZRZF( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void STZRZF_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void stzrzf( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void stzrzf_( const int* m, const int* n, float* a, const int* lda, float* tau, float* work, const int* lwork, int* info ); void XERBLA_ARRAY( const char* srname_array, const int* srname_len, const int* info ); void XERBLA_ARRAY_( const char* srname_array, const int* srname_len, const int* info ); void xerbla_array( const char* srname_array, const int* srname_len, const int* info ); void xerbla_array_( const char* srname_array, const int* srname_len, const int* info ); void ZBDSQR( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void ZBDSQR_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void zbdsqr( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void zbdsqr_( const char* uplo, const int* n, const int* ncvt, const int* nru, const int* ncc, double* d, double* e, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* u, const int* ldu, MKL_Complex16* c, const int* ldc, double* rwork, int* info ); void ZCGESV( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZCGESV_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcgesv( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcgesv_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZCPOSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZCPOSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcposv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void zcposv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter, int* info ); void ZDRSCL( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void ZDRSCL_( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void zdrscl( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void zdrscl_( const int* n, const double* sa, MKL_Complex16* sx, const int* incx ); void ZGBBRD( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void ZGBBRD_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void zgbbrd( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void zgbbrd_( const char* vect, const int* m, const int* n, const int* ncc, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* pt, const int* ldpt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, double* rwork, int* info ); void ZGBCON( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGBCON_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgbcon( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgbcon_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGBEQUB( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBEQUB_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequb( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequb_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBEQU( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBEQU_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequ( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgbequ_( const int* m, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGBRFS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBRFS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbrfs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbrfs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBRFSX( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBRFSX_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbrfsx( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbrfsx_( const char* trans, const char* equed, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBSV( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGBSV_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbsv( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbsv_( const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGBSVX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBSVX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbsvx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgbsvx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGBSVXX( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBSVXX_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbsvxx( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgbsvxx_( const char* fact, const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGBTF2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTF2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtf2( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtf2_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTRF( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTRF_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtrf( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void zgbtrf_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, int* ipiv, int* info ); void ZGBTRS( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGBTRS_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbtrs( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgbtrs_( const char* trans, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGEBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGEBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zgebak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zgebak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* scale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGEBAL( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void ZGEBAL_( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void zgebal( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void zgebal_( const char* job, const int* n, MKL_Complex16* a, const int* lda, int* ilo, int* ihi, double* scale, int* info ); void ZGEBD2( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void ZGEBD2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void zgebd2( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void zgebd2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int* info ); void ZGEBRD( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void ZGEBRD_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void zgebrd( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void zgebrd_( const int* m, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, const int* lwork, int* info ); void ZGECON( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGECON_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgecon( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zgecon_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZGEEQUB( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEEQUB_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequb( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequb_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEEQU( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEEQU_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequ( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void zgeequ_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax, int* info ); void ZGEES( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEES_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgees( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgees_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEESX( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEESX_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgeesx( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgeesx_( const char* jobvs, const char* sort, MKL_Z_SELECT_FUNCTION_1 select, const char* sense, const int* n, MKL_Complex16* a, const int* lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, const int* ldvs, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGEEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGS( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGS_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegs( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegs_( const char* jobvsl, const char* jobvsr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEGV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegv( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgegv_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEHD2( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEHD2_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgehd2( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgehd2_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEHRD( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEHRD_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgehrd( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgehrd_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGELQ2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGELQ2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgelq2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgelq2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGELQF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGELQF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgelqf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgelqf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGELSD( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGELSD_( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgelsd( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgelsd_( const int* m, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGELS( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZGELS_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgels( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zgels_( const char* trans, const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZGELSS( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGELSS_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelss( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelss_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* s, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGELSX( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void ZGELSX_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void zgelsx( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void zgelsx_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* info ); void ZGELSY( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGELSY_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelsy( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgelsy_( const int* m, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* jpvt, const double* rcond, int* rank, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEQL2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQL2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeql2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeql2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQLF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQLF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqlf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqlf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQP3( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEQP3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeqp3( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgeqp3_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGEQPF( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void ZGEQPF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void zgeqpf( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void zgeqpf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork, int* info ); void ZGEQR2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQR2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQR2P( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQR2P_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2p( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgeqr2p_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGEQRF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQRF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQRFP( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGEQRFP_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrfp( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgeqrfp_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGERFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGERFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgerfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgerfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGERFSX( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGERFSX_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgerfsx( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgerfsx_( const char* trans, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGERQ2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGERQ2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgerq2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zgerq2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGERQF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGERQF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgerqf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zgerqf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZGESC2( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void ZGESC2_( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void zgesc2( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void zgesc2_( const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* rhs, const int* ipiv, const int* jpiv, double* scale ); void ZGESDD( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGESDD_( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgesdd( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void zgesdd_( const char* jobz, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* info ); void ZGESVD( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGESVD_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgesvd( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zgesvd_( const char* jobu, const char* jobvt, const int* m, const int* n, MKL_Complex16* a, const int* lda, double* s, MKL_Complex16* u, const int* ldu, MKL_Complex16* vt, const int* ldvt, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGESV( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGESV_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgesv( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgesv_( const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGESVX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGESVX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgesvx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgesvx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGESVXX( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGESVXX_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgesvxx( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zgesvxx_( const char* fact, const char* trans, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZGETC2( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void ZGETC2_( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void zgetc2( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void zgetc2_( const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* jpiv, int* info ); void ZGETF2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETF2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetf2( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetf2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETRF( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZGETRF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zgetrf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void MKL_ZGETRFNPI( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void MKL_ZGETRFNPI_( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnpi( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void mkl_zgetrfnpi_( const int* m, const int* n, const int* nfact, MKL_Complex16* a, const int* lda, int* info ); void ZGETRI( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZGETRI_( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zgetri( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zgetri_( const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZGETRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGETRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgetrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgetrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGGBAK( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGGBAK_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zggbak( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void zggbak_( const char* job, const char* side, const int* n, const int* ilo, const int* ihi, const double* lscale, const double* rscale, const int* m, MKL_Complex16* v, const int* ldv, int* info ); void ZGGBAL( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void ZGGBAL_( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void zggbal( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void zggbal_( const char* job, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work, int* info ); void ZGGES( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGGES_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void zgges_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, MKL_Complex16* work, const int* lwork, double* rwork, int* bwork, int* info ); void ZGGESX( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void ZGGESX_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void zggesx( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void zggesx_( const char* jobvsl, const char* jobvsr, const char* sort, MKL_Z_SELECT_FUNCTION_2 selctg, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, const int* ldvsl, MKL_Complex16* vsr, const int* ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, const int* liwork, int* bwork, int* info ); void ZGGEV( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGGEV_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zggev_( const char* jobvl, const char* jobvr, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZGGEVX( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void ZGGEVX_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void zggevx( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void zggevx_( const char* balanc, const char* jobvl, const char* jobvr, const char* sense, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* bwork, int* info ); void ZGGGLM( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void ZGGGLM_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void zggglm( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void zggglm_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, const int* lwork, int* info ); void ZGGHRD( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void ZGGHRD_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void zgghrd( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void zgghrd_( const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* info ); void ZGGLSE( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void ZGGLSE_( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void zgglse( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void zgglse_( const int* m, const int* n, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, const int* lwork, int* info ); void ZGGQRF( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGQRF_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggqrf( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggqrf_( const int* n, const int* m, const int* p, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGRQF( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGRQF_( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggrqf( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void zggrqf_( const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* taua, MKL_Complex16* b, const int* ldb, MKL_Complex16* taub, MKL_Complex16* work, const int* lwork, int* info ); void ZGGSVD( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZGGSVD_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zggsvd( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zggsvd_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* n, const int* p, int* k, int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZGGSVP( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGGSVP_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zggsvp( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zggsvp_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, int* k, int* l, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZGTCON( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZGTCON_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zgtcon( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zgtcon_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZGTRFS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTRFS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtrfs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtrfs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTSV( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZGTSV_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zgtsv( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zgtsv_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZGTSVX( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTSVX_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtsvx( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zgtsvx_( const char* fact, const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZGTTRF( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void ZGTTRF_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void zgttrf( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void zgttrf_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv, int* info ); void ZGTTRS( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGTTRS_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgttrs( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zgttrs_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZGTTS2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void ZGTTS2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void zgtts2( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void zgtts2_( const int* itrans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, const int* ldb ); void ZHBEVD( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEVD_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbevd_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBEV( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBEV_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbev( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbev_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBEVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBEVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbevx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBGST( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void ZHBGST_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void zhbgst( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void zhbgst_( const char* vect, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, const MKL_Complex16* bb, const int* ldbb, MKL_Complex16* x, const int* ldx, MKL_Complex16* work, double* rwork, int* info ); void ZHBGVD( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBGVD_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbgvd( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhbgvd_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHBGV( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBGV_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbgv( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhbgv_( const char* jobz, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHBGVX( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBGVX_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbgvx( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhbgvx_( const char* jobz, const char* range, const char* uplo, const int* n, const int* ka, const int* kb, MKL_Complex16* ab, const int* ldab, MKL_Complex16* bb, const int* ldbb, MKL_Complex16* q, const int* ldq, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHBTRD( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZHBTRD_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zhbtrd( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zhbtrd_( const char* vect, const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZHECON( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHECON_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhecon_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHEEQUB( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZHEEQUB_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zheequb( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zheequb_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZHEEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEV( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zheev_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEEVR( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVR_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zheevr_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zheevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEGS2( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGS2_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegs2( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegs2_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGST( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGST_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegst( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void zhegst_( const int* itype, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, int* info ); void ZHEGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhegvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhegvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHEGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhegv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, double* w, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHEGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHEGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhegvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void zhegvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* iwork, int* ifail, int* info ); void ZHERFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHERFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zherfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zherfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHERFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHERFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zherfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zherfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHESV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zhesv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZHESVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHESVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhesvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhesvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHESVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHESVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zhesvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zhesvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZHETD2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHETD2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void zhetd2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void zhetd2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHETF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zhetf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZHETRD( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRD_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zhetrd_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRI_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zhetri_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZHETRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHETRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhetrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHFRK( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void ZHFRK_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void zhfrk( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void zhfrk_( const char* transr, const char* uplo, const char* trans, const int* n, const int* k, const double* alpha, const MKL_Complex16* a, const int* lda, const double* beta, MKL_Complex16* c ); void ZHGEQZ( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHGEQZ_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhgeqz( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zhgeqz_( const char* job, const char* compq, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* t, const int* ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZHPCON( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHPCON_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhpcon( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zhpcon_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZHPEVD( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPEVD_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpevd( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpevd_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPEV( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPEV_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpev( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpev_( const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPEVX( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPEVX_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpevx( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpevx_( const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPGST( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void ZHPGST_( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void zhpgst( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void zhpgst_( const int* itype, const char* uplo, const int* n, MKL_Complex16* ap, const MKL_Complex16* bp, int* info ); void ZHPGVD( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPGVD_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpgvd( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zhpgvd_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZHPGV( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPGV_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpgv( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void zhpgv_( const int* itype, const char* jobz, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* info ); void ZHPGVX( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPGVX_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpgvx( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void zhpgvx_( const int* itype, const char* jobz, const char* range, const char* uplo, const int* n, MKL_Complex16* ap, MKL_Complex16* bp, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail, int* info ); void ZHPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhpsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhpsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhpsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zhpsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZHPTRD( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHPTRD_( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void zhptrd( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void zhptrd_( const char* uplo, const int* n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau, int* info ); void ZHPTRF( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZHPTRF_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zhptrf( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zhptrf_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZHPTRI( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZHPTRI_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zhptri( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zhptri_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZHPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zhptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZHSEIN( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void ZHSEIN_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void zhsein( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void zhsein_( const char* side, const char* eigsrc, const char* initv, const int* select, const int* n, const MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr, int* info ); void ZHSEQR( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZHSEQR_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zhseqr( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zhseqr_( const char* job, const char* compz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLABRD( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void ZLABRD_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void zlabrd( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void zlabrd_( const int* m, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy ); void ZLACGV( const int* n, MKL_Complex16* x, const int* incx ); void ZLACGV_( const int* n, MKL_Complex16* x, const int* incx ); void zlacgv( const int* n, MKL_Complex16* x, const int* incx ); void zlacgv_( const int* n, MKL_Complex16* x, const int* incx ); void ZLACN2( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void ZLACN2_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void zlacn2( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void zlacn2_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); void ZLACON( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void ZLACON_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void zlacon( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void zlacon_( const int* n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase ); void ZLACP2( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACP2_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacp2( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacp2_( const char* uplo, const int* m, const int* n, const double* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACPY( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACPY_( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacpy( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void zlacpy_( const char* uplo, const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb ); void ZLACRM( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLACRM_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlacrm( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlacrm_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const double* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLACRT( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void ZLACRT_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void zlacrt( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void zlacrt_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const MKL_Complex16* c, const MKL_Complex16* s ); void ZLADIV( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void ZLADIV_( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void zladiv( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void zladiv_( MKL_Complex16* ret_value, const MKL_Complex16* x, const MKL_Complex16* y ); void ZLAED0( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void ZLAED0_( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void zlaed0( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void zlaed0_( const int* qsiz, const int* n, double* d, double* e, MKL_Complex16* q, const int* ldq, MKL_Complex16* qstore, const int* ldqs, double* rwork, int* iwork, int* info ); void ZLAED7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZLAED7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlaed7( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlaed7_( const int* n, const int* cutpnt, const int* qsiz, const int* tlvls, const int* curlvl, const int* curpbm, double* d, MKL_Complex16* q, const int* ldq, const double* rho, int* indxq, double* qstore, int* qptr, const int* prmptr, const int* perm, const int* givptr, const int* givcol, const double* givnum, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZLAED8( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void ZLAED8_( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void zlaed8( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void zlaed8_( int* k, const int* n, const int* qsiz, MKL_Complex16* q, const int* ldq, double* d, double* rho, const int* cutpnt, const double* z, double* dlamda, MKL_Complex16* q2, const int* ldq2, double* w, int* indxp, int* indx, const int* indxq, int* perm, int* givptr, int* givcol, double* givnum, int* info ); void ZLAEIN( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void ZLAEIN_( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void zlaein( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void zlaein_( const int* rightv, const int* noinit, const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* w, MKL_Complex16* v, MKL_Complex16* b, const int* ldb, double* rwork, const double* eps3, const double* smlnum, int* info ); void ZLAESY( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void ZLAESY_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void zlaesy( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void zlaesy_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, MKL_Complex16* rt1, MKL_Complex16* rt2, MKL_Complex16* evscal, MKL_Complex16* cs1, MKL_Complex16* sn1 ); void ZLAEV2( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void ZLAEV2_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void zlaev2( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void zlaev2_( const MKL_Complex16* a, const MKL_Complex16* b, const MKL_Complex16* c, double* rt1, double* rt2, double* cs1, MKL_Complex16* sn1 ); void ZLAG2C( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLAG2C_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlag2c( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlag2c_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLAGS2( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void ZLAGS2_( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void zlags2( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void zlags2_( const int* upper, const double* a1, const MKL_Complex16* a2, const double* a3, const double* b1, const MKL_Complex16* b2, const double* b3, double* csu, MKL_Complex16* snu, double* csv, MKL_Complex16* snv, double* csq, MKL_Complex16* snq ); void ZLAGTM( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void ZLAGTM_( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void zlagtm( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void zlagtm_( const char* trans, const int* n, const int* nrhs, const double* alpha, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* x, const int* ldx, const double* beta, MKL_Complex16* b, const int* ldb ); void ZLAHEF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHEF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlahef_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAHQR( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void ZLAHQR_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void zlahqr( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void zlahqr_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* info ); void ZLAHR2( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAHR2_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahr2( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahr2_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAHRD( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAHRD_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahrd( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void zlahrd_( const int* n, const int* k, const int* nb, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* t, const int* ldt, MKL_Complex16* y, const int* ldy ); void ZLAIC1( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void ZLAIC1_( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void zlaic1( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void zlaic1_( const int* job, const int* j, const MKL_Complex16* x, const double* sest, const MKL_Complex16* w, const MKL_Complex16* gamma, double* sestpr, MKL_Complex16* s, MKL_Complex16* c ); void ZLALS0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void ZLALS0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void zlals0( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void zlals0_( const int* icompq, const int* nl, const int* nr, const int* sqre, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const int* perm, const int* givptr, const int* givcol, const int* ldgcol, const double* givnum, const int* ldgnum, const double* poles, const double* difl, const double* difr, const double* z, const int* k, const double* c, const double* s, double* rwork, int* info ); void ZLALSA( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void ZLALSA_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void zlalsa( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void zlalsa_( const int* icompq, const int* smlsiz, const int* n, const int* nrhs, MKL_Complex16* b, const int* ldb, MKL_Complex16* bx, const int* ldbx, const double* u, const int* ldu, const double* vt, const int* k, const double* difl, const double* difr, const double* z, const double* poles, const int* givptr, const int* givcol, const int* ldgcol, const int* perm, const double* givnum, const double* c, const double* s, double* rwork, int* iwork, int* info ); void ZLALSD( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void ZLALSD_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlalsd( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); void zlalsd_( const char* uplo, const int* smlsiz, const int* n, const int* nrhs, double* d, double* e, MKL_Complex16* b, const int* ldb, const double* rcond, int* rank, MKL_Complex16* work, double* rwork, int* iwork, int* info ); double ZLANGB( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANGB_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double zlangb( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double zlangb_( const char* norm, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANGE( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANGE_( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlange( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlange_( const char* norm, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANGT( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double ZLANGT_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double zlangt( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double zlangt_( const char* norm, const int* n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du ); double ZLANHB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANHB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlanhb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlanhb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANHE( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHE_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhe( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhe_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHF( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double ZLANHF_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double zlanhf( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double zlanhf_( const char* norm, const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, double* work ); double ZLANHP( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANHP_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlanhp( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlanhp_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANHS( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHS_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhs( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlanhs_( const char* norm, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANHT( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double ZLANHT_( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double zlanht( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double zlanht_( const char* norm, const int* n, const double* d, const MKL_Complex16* e ); double ZLANSB( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANSB_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlansb( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlansb_( const char* norm, const char* uplo, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANSP( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANSP_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlansp( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double zlansp_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* ap, double* work ); double ZLANSY( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANSY_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlansy( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlansy_( const char* norm, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANTB( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANTB_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlantb( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double zlantb_( const char* norm, const char* uplo, const char* diag, const int* n, const int* k, const MKL_Complex16* ab, const int* ldab, double* work ); double ZLANTP( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double ZLANTP_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double zlantp( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double zlantp_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* work ); double ZLANTR( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double ZLANTR_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlantr( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); double zlantr_( const char* norm, const char* uplo, const char* diag, const int* m, const int* n, const MKL_Complex16* a, const int* lda, double* work ); void ZLAPLL( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void ZLAPLL_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void zlapll( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void zlapll_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* ssmin ); void ZLAPMT( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void ZLAPMT_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmt( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void zlapmt_( const int* forwrd, const int* m, const int* n, MKL_Complex16* x, const int* ldx, int* k ); void ZLAQGB( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQGB_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqgb( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqgb_( const int* m, const int* n, const int* kl, const int* ku, MKL_Complex16* ab, const int* ldab, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQGE( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQGE_( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqge( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void zlaqge_( const int* m, const int* n, MKL_Complex16* a, const int* lda, const double* r, const double* c, const double* rowcnd, const double* colcnd, const double* amax, char* equed ); void ZLAQHB( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void ZLAQHB_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void zlaqhb( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void zlaqhb_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, double* s, const double* scond, const double* amax, char* equed ); void ZLAQHE( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQHE_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhe( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhe_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQHP( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQHP_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhp( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqhp_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQP2( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void ZLAQP2_( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void zlaqp2( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void zlaqp2_( const int* m, const int* n, const int* offset, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* work ); void ZLAQPS( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void ZLAQPS_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void zlaqps( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void zlaqps_( const int* m, const int* n, const int* offset, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* jpvt, MKL_Complex16* tau, double* vn1, double* vn2, MKL_Complex16* auxv, MKL_Complex16* f, const int* ldf ); void ZLAQR0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr0( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr0_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR1( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void ZLAQR1_( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void zlaqr1( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void zlaqr1_( const int* n, const MKL_Complex16* h, const int* ldh, const MKL_Complex16* s1, MKL_Complex16* s2, MKL_Complex16* v ); void ZLAQR2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr2( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr2_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr3( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void zlaqr3_( const int* wantt, const int* wantz, const int* n, const int* ktop, const int* kbot, const int* nw, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, int* ns, int* nd, MKL_Complex16* sh, MKL_Complex16* v, const int* ldv, const int* nh, MKL_Complex16* t, const int* ldt, const int* nv, MKL_Complex16* wv, const int* ldwv, MKL_Complex16* work, const int* lwork ); void ZLAQR4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr4( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zlaqr4_( const int* wantt, const int* wantz, const int* n, const int* ilo, const int* ihi, MKL_Complex16* h, const int* ldh, MKL_Complex16* w, int* iloz, int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZLAQR5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void ZLAQR5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void zlaqr5( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void zlaqr5_( const int* wantt, const int* wantz, const int* kacc22, const int* n, const int* ktop, const int* kbot, const int* nshfts, MKL_Complex16* s, MKL_Complex16* h, const int* ldh, const int* iloz, const int* ihiz, MKL_Complex16* z, const int* ldz, MKL_Complex16* v, const int* ldv, MKL_Complex16* u, const int* ldu, const int* nv, MKL_Complex16* wv, const int* ldwv, const int* nh, MKL_Complex16* wh, const int* ldwh ); void ZLAQSB( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSB_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsb( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsb_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSP( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSP_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsp( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsp_( const char* uplo, const int* n, MKL_Complex16* ap, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSY( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAQSY_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsy( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void zlaqsy_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const double* s, const double* scond, const double* amax, char* equed ); void ZLAR1V( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void ZLAR1V_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void zlar1v( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void zlar1v_( const int* n, const int* b1, const int* bn, const double* lambda, const double* d, const double* l, const double* ld, const double* lld, const double* pivmin, const double* gaptol, MKL_Complex16* z, const int* wantnc, int* negcnt, double* ztz, double* mingma, int* r, int* isuppz, double* nrminv, double* resid, double* rqcorr, double* work ); void ZLAR2V( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void ZLAR2V_( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void zlar2v( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void zlar2v_( const int* n, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* z, const int* incx, const double* c, const MKL_Complex16* s, const int* incc ); void ZLARCM( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLARCM_( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlarcm( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void zlarcm_( const int* m, const int* n, const double* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* rwork ); void ZLARFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARF( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARF_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarf( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarf_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARFG( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFG_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfg( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfg_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFGP( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFGP_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfgp( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfgp_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFP( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFP_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfp( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void zlarfp_( const int* n, MKL_Complex16* alpha, MKL_Complex16* x, const int* incx, MKL_Complex16* tau ); void ZLARFT( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLARFT_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarft( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarft_( const char* direct, const char* storev, const int* n, const int* k, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLARFX( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARFX_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfx( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarfx_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARGV( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void ZLARGV_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void zlargv( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void zlargv_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, double* c, const int* incc ); void ZLARNV( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void ZLARNV_( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void zlarnv( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void zlarnv_( const int* idist, int* iseed, const int* n, MKL_Complex16* x ); void ZLARRV( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void ZLARRV_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void zlarrv( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void zlarrv_( const int* n, const double* vl, const double* vu, double* d, double* l, double* pivmin, const int* isplit, const int* m, const int* dol, const int* dou, const double* minrgp, const double* rtol1, const double* rtol2, double* w, double* werr, double* wgap, const int* iblock, const int* indexw, const double* gers, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, int* iwork, int* info ); void ZLARSCL2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLARSCL2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlarscl2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlarscl2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLARTG( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void ZLARTG_( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void zlartg( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void zlartg_( const MKL_Complex16* f, const MKL_Complex16* g, double* cs, MKL_Complex16* sn, MKL_Complex16* r ); void ZLARTV( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void ZLARTV_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void zlartv( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void zlartv_( const int* n, MKL_Complex16* x, const int* incx, MKL_Complex16* y, const int* incy, const double* c, const MKL_Complex16* s, const int* incc ); void ZLARZB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARZB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarzb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void zlarzb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* ldwork ); void ZLARZ( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARZ_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarz( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void zlarz_( const char* side, const int* m, const int* n, const int* l, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work ); void ZLARZT( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLARZT_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarzt( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void zlarzt_( const char* direct, const char* storev, const int* n, const int* k, MKL_Complex16* v, const int* ldv, const MKL_Complex16* tau, MKL_Complex16* t, const int* ldt ); void ZLASCL( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLASCL_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlascl( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlascl_( const char* type, const int* kl, const int* ku, const double* cfrom, const double* cto, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLASCL2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLASCL2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlascl2( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void zlascl2_( const int* m, const int* n, const double* d, MKL_Complex16* x, const int* ldx ); void ZLASET( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void ZLASET_( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void zlaset( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void zlaset_( const char* uplo, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* beta, MKL_Complex16* a, const int* lda ); void ZLASR( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void ZLASR_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void zlasr( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void zlasr_( const char* side, const char* pivot, const char* direct, const int* m, const int* n, const double* c, const double* s, MKL_Complex16* a, const int* lda ); void ZLASSQ( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void ZLASSQ_( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void zlassq( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void zlassq_( const int* n, const MKL_Complex16* x, const int* incx, double* scale, double* sumsq ); void ZLASWP( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void ZLASWP_( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void zlaswp( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void zlaswp_( const int* n, MKL_Complex16* a, const int* lda, const int* k1, const int* k2, const int* ipiv, const int* incx ); void ZLASYF( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLASYF_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void zlasyf_( const char* uplo, const int* n, const int* nb, int* kb, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* w, const int* ldw, int* info ); void ZLAT2C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLAT2C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlat2c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void zlat2c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex8* sa, const int* ldsa, int* info ); void ZLATBS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATBS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatbs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatbs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATDF( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void ZLATDF_( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void zlatdf( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void zlatdf_( const int* ijob, const int* n, const MKL_Complex16* z, const int* ldz, MKL_Complex16* rhs, double* rdsum, double* rdscal, const int* ipiv, const int* jpiv ); void ZLATPS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATPS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatps( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatps_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* ap, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATRD( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void ZLATRD_( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void zlatrd( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void zlatrd_( const char* uplo, const int* n, const int* nb, MKL_Complex16* a, const int* lda, double* e, MKL_Complex16* tau, MKL_Complex16* w, const int* ldw ); void ZLATRS( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATRS_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatrs( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void zlatrs_( const char* uplo, const char* trans, const char* diag, const char* normin, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* x, double* scale, double* cnorm, int* info ); void ZLATRZ( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void ZLATRZ_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void zlatrz( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void zlatrz_( const int* m, const int* n, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work ); void ZLATZM( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void ZLATZM_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void zlatzm( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void zlatzm_( const char* side, const int* m, const int* n, const MKL_Complex16* v, const int* incv, const MKL_Complex16* tau, MKL_Complex16* c1, MKL_Complex16* c2, const int* ldc, MKL_Complex16* work ); void ZLAUU2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLAUU2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauu2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauu2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLAUUM( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZLAUUM_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauum( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zlauum_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPBCON( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPBCON_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpbcon( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpbcon_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPBEQU( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void ZPBEQU_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void zpbequ( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void zpbequ_( const char* uplo, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* s, double* scond, double* amax, int* info ); void ZPBRFS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBRFS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbrfs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbrfs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBSTF( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBSTF_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbstf( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbstf_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBSV( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPBSV_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbsv( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbsv_( const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPBSVX( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBSVX_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbsvx( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpbsvx_( const char* fact, const char* uplo, const int* n, const int* kd, const int* nrhs, MKL_Complex16* ab, const int* ldab, MKL_Complex16* afb, const int* ldafb, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPBTF2( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTF2_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtf2( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtf2_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTRF( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTRF_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtrf( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void zpbtrf_( const char* uplo, const int* n, const int* kd, MKL_Complex16* ab, const int* ldab, int* info ); void ZPBTRS( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPBTRS_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbtrs( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void zpbtrs_( const char* uplo, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZPFTRF( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRF_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftrf( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftrf_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRI( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRI_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftri( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void zpftri_( const char* transr, const char* uplo, const int* n, MKL_Complex16* a, int* info ); void ZPFTRS( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void ZPFTRS_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void zpftrs( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void zpftrs_( const char* transr, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb, int* info ); void ZPOCON( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPOCON_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpocon( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zpocon_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPOEQUB( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPOEQUB_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequb( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequb_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPOEQU( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPOEQU_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequ( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void zpoequ_( const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, int* info ); void ZPORFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPORFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zporfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zporfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPORFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPORFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zporfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zporfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPOSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPOSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zposv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zposv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPOSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPOSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zposvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zposvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPOSVXX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPOSVXX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zposvxx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zposvxx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZPOTF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRI( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRI_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotri( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void zpotri_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZPOTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPOTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zpotrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void zpotrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZPPCON( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPPCON_( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zppcon( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void zppcon_( const char* uplo, const int* n, const MKL_Complex16* ap, const double* anorm, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZPPEQU( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void ZPPEQU_( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void zppequ( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void zppequ_( const char* uplo, const int* n, const MKL_Complex16* ap, double* s, double* scond, double* amax, int* info ); void ZPPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zpprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zppsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zppsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zppsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zppsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPPTRF( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRF_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptrf( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptrf_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRI( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRI_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptri( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void zpptri_( const char* uplo, const int* n, MKL_Complex16* ap, int* info ); void ZPPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zpptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void zpptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZPSTF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPSTF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPSTRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPSTRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void zpstrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* piv, int* rank, const double* tol, double* work, int* info ); void ZPTCON( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void ZPTCON_( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void zptcon( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void zptcon_( const int* n, const double* d, const MKL_Complex16* e, const double* anorm, double* rcond, double* rwork, int* info ); void ZPTEQR( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZPTEQR_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zpteqr( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zpteqr_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZPTRFS( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTRFS_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptrfs( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptrfs_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTSV( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTSV_( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zptsv( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zptsv_( const int* n, const int* nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTSVX( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTSVX_( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptsvx( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zptsvx_( const char* fact, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZPTTRF( const int* n, double* d, MKL_Complex16* e, int* info ); void ZPTTRF_( const int* n, double* d, MKL_Complex16* e, int* info ); void zpttrf( const int* n, double* d, MKL_Complex16* e, int* info ); void zpttrf_( const int* n, double* d, MKL_Complex16* e, int* info ); void ZPTTRS( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTTRS_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zpttrs( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void zpttrs_( const char* uplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb, int* info ); void ZPTTS2( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void ZPTTS2_( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void zptts2( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void zptts2_( const int* iuplo, const int* n, const int* nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, const int* ldb ); void ZROT( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void ZROT_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void zrot( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void zrot_( const int* n, MKL_Complex16* cx, const int* incx, MKL_Complex16* cy, const int* incy, const double* c, const MKL_Complex16* s ); void ZSPCON( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSPCON_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zspcon( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zspcon_( const char* uplo, const int* n, const MKL_Complex16* ap, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSPMV( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSPMV_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zspmv( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zspmv_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* ap, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSPR( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void ZSPR_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void zspr( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void zspr_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* ap ); void ZSPRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsprfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsprfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSPSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zspsv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zspsv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSPSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zspsvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zspsvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSPTRF( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZSPTRF_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zsptrf( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void zsptrf_( const char* uplo, const int* n, MKL_Complex16* ap, int* ipiv, int* info ); void ZSPTRI( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZSPTRI_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zsptri( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void zsptri_( const char* uplo, const int* n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work, int* info ); void ZSPTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSPTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsptrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsptrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSTEDC( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZSTEDC_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zstedc( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void zstedc_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, double* rwork, const int* lrwork, int* iwork, const int* liwork, int* info ); void ZSTEGR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEGR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstegr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstegr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, const double* abstol, int* m, double* w, MKL_Complex16* z, const int* ldz, int* isuppz, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEIN( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void ZSTEIN_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void zstein( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void zstein_( const int* n, const double* d, const double* e, const int* m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, const int* ldz, double* work, int* iwork, int* ifail, int* info ); void ZSTEMR( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEMR_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstemr( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void zstemr_( const char* jobz, const char* range, const int* n, double* d, double* e, const double* vl, const double* vu, const int* il, const int* iu, int* m, double* w, MKL_Complex16* z, const int* ldz, const int* nzc, int* isuppz, int* tryrac, double* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZSTEQR( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZSTEQR_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zsteqr( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void zsteqr_( const char* compz, const int* n, double* d, double* e, MKL_Complex16* z, const int* ldz, double* work, int* info ); void ZSYCON( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYCON_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void zsycon_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const int* ipiv, const double* anorm, double* rcond, MKL_Complex16* work, int* info ); void ZSYEQUB( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZSYEQUB_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zsyequb( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void zsyequb_( char* uplo, const int* n, const MKL_Complex16* a, const int* lda, double* s, double* scond, double* amax, MKL_Complex16* work, int* info ); void ZSYMV( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSYMV_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zsymv( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void zsymv_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const MKL_Complex16* beta, MKL_Complex16* y, const int* incy ); void ZSYR( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void ZSYR_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void zsyr( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void zsyr_( const char* uplo, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* x, const int* incx, MKL_Complex16* a, const int* lda ); void ZSYRFS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSYRFS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsyrfs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void zsyrfs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZSYRFSX( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYRFSX_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsyrfsx( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsyrfsx_( const char* uplo, const char* equed, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYSV( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSV_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void zsysv_( const char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* lwork, int* info ); void ZSYSVX( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZSYSVX_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zsysvx( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void zsysvx_( const char* fact, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, const MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, const int* lwork, double* rwork, int* info ); void ZSYSVXX( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYSVXX_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsysvxx( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void zsysvxx_( const char* fact, char* uplo, const int* n, const int* nrhs, MKL_Complex16* a, const int* lda, MKL_Complex16* af, const int* ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, const int* ldb, MKL_Complex16* x, const int* ldx, double* rcond, double* rpvgrw, double* berr, const int* n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, const int* nparams, double* params, MKL_Complex16* work, double* rwork, int* info ); void ZSYTF2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTF2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void zsytf2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, int* info ); void ZSYTRF( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRF_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zsytrf_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZSYTRI( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRI_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void zsytri_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, int* info ); void ZSYTRS( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZSYTRS_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void zsytrs_( const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* b, const int* ldb, int* info ); void ZTBCON( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTBCON_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztbcon( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztbcon_( const char* norm, const char* uplo, const char* diag, const int* n, const int* kd, const MKL_Complex16* ab, const int* ldab, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTBRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTBRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztbrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztbrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTBTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZTBTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ztbtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ztbtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* kd, const int* nrhs, const MKL_Complex16* ab, const int* ldab, MKL_Complex16* b, const int* ldb, int* info ); void ZTFSM( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ZTFSM_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ztfsm( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ztfsm_( const char* transr, const char* side, const char* uplo, const char* trans, const char* diag, const int* m, const int* n, const MKL_Complex16* alpha, const MKL_Complex16* a, MKL_Complex16* b, const int* ldb ); void ZTFTRI( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ZTFTRI_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ztftri( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ztftri_( const char* transr, const char* uplo, const char* diag, const int* n, MKL_Complex16* a, int* info ); void ZTFTTP( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ZTFTTP_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ztfttp( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ztfttp_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* ap, int* info ); void ZTFTTR( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ZTFTTR_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ztfttr( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ztfttr_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* arf, MKL_Complex16* a, const int* lda, int* info ); void ZTGEVC( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTGEVC_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztgevc( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztgevc_( const char* side, const char* howmny, const int* select, const int* n, const MKL_Complex16* s, const int* lds, const MKL_Complex16* p, const int* ldp, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTGEX2( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ZTGEX2_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ztgex2( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ztgex2_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* j1, int* info ); void ZTGEXC( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ZTGEXC_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ztgexc( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ztgexc_( const int* wantq, const int* wantz, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, const int* ifst, int* ilst, int* info ); void ZTGSEN( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZTGSEN_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ztgsen( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ztgsen_( const int* ijob, const int* wantq, const int* wantz, const int* select, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, const int* ldq, MKL_Complex16* z, const int* ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, const int* liwork, int* info ); void ZTGSJA( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ZTGSJA_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ztgsja( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ztgsja_( const char* jobu, const char* jobv, const char* jobq, const int* m, const int* p, const int* n, const int* k, const int* l, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, const double* tola, const double* tolb, double* alpha, double* beta, MKL_Complex16* u, const int* ldu, MKL_Complex16* v, const int* ldv, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* ncycle, int* info ); void ZTGSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTGSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* dif, const int* mm, int* m, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTGSY2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ZTGSY2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ztgsy2( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ztgsy2_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* rdsum, double* rdscal, int* info ); void ZTGSYL( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTGSYL_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsyl( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ztgsyl_( const char* trans, const int* ijob, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, const MKL_Complex16* d, const int* ldd, const MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, double* scale, double* dif, MKL_Complex16* work, const int* lwork, int* iwork, int* info ); void ZTPCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTPCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztpcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztpcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTPRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTPRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztprfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztprfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTPTRI( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ZTPTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ztptri( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ztptri_( const char* uplo, const char* diag, const int* n, MKL_Complex16* ap, int* info ); void ZTPTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZTPTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ztptrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ztptrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* ap, MKL_Complex16* b, const int* ldb, int* info ); void ZTPTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ZTPTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ztpttf( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ztpttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* arf, int* info ); void ZTPTTR( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ZTPTTR_( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ztpttr( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ztpttr_( const char* uplo, const int* n, const MKL_Complex16* ap, MKL_Complex16* a, const int* lda, int* info ); void ZTRCON( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTRCON_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztrcon( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ztrcon_( const char* norm, const char* uplo, const char* diag, const int* n, const MKL_Complex16* a, const int* lda, double* rcond, MKL_Complex16* work, double* rwork, int* info ); void ZTREVC( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTREVC_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztrevc( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ztrevc_( const char* side, const char* howmny, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* vl, const int* ldvl, MKL_Complex16* vr, const int* ldvr, const int* mm, int* m, MKL_Complex16* work, double* rwork, int* info ); void ZTREXC( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ZTREXC_( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ztrexc( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ztrexc_( const char* compq, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, const int* ifst, const int* ilst, int* info ); void ZTRRFS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTRRFS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztrrfs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ztrrfs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, const MKL_Complex16* x, const int* ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork, int* info ); void ZTRSEN( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ZTRSEN_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ztrsen( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ztrsen_( const char* job, const char* compq, const int* select, const int* n, MKL_Complex16* t, const int* ldt, MKL_Complex16* q, const int* ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, const int* lwork, int* info ); void ZTRSNA( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ZTRSNA_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ztrsna( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ztrsna_( const char* job, const char* howmny, const int* select, const int* n, const MKL_Complex16* t, const int* ldt, const MKL_Complex16* vl, const int* ldvl, const MKL_Complex16* vr, const int* ldvr, double* s, double* sep, const int* mm, int* m, MKL_Complex16* work, const int* ldwork, double* rwork, int* info ); void ZTRSYL( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ZTRSYL_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ztrsyl( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ztrsyl_( const char* trana, const char* tranb, const int* isgn, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, double* scale, int* info ); void ZTRTI2( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTI2_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrti2( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrti2_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTRI( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTRI_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrtri( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ztrtri_( const char* uplo, const char* diag, const int* n, MKL_Complex16* a, const int* lda, int* info ); void ZTRTRS( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZTRTRS_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ztrtrs( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ztrtrs_( const char* uplo, const char* trans, const char* diag, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, int* info ); void ZTRTTF( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ZTRTTF_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ztrttf( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ztrttf_( const char* transr, const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* arf, int* info ); void ZTRTTP( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ZTRTTP_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ztrttp( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ztrttp_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, MKL_Complex16* ap, int* info ); void ZTZRQF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ZTZRQF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ztzrqf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ztzrqf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, int* info ); void ZTZRZF( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZTZRZF_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ztzrzf( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ztzrzf_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNG2L( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNG2L_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2l( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2l_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNG2R( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNG2R_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2r( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zung2r_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGBR( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGBR_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungbr( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungbr_( const char* vect, const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGHR( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGHR_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunghr( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunghr_( const int* n, const int* ilo, const int* ihi, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGL2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGL2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungl2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungl2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGLQ( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGLQ_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunglq( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zunglq_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQL( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQL_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungql( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungql_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQR( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGQR_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungqr( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungqr_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGR2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGR2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungr2( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void zungr2_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, int* info ); void ZUNGRQ( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGRQ_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungrq( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungrq_( const int* m, const int* n, const int* k, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGTR( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNGTR_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungtr( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void zungtr_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* work, const int* lwork, int* info ); void ZUNM2L( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNM2L_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2l( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2l_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNM2R( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNM2R_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2r( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunm2r_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMBR( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMBR_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmbr( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmbr_( const char* vect, const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMHR( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMHR_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmhr( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmhr_( const char* side, const char* trans, const int* m, const int* n, const int* ilo, const int* ihi, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNML2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNML2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunml2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunml2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMLQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMLQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmlq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmlq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQL( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQL_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmql( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmql_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQR( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMQR_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmqr( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmqr_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMR2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMR2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr2( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr2_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMR3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMR3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr3( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zunmr3_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUNMRQ( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMRQ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrq( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrq_( const char* side, const char* trans, const int* m, const int* n, const int* k, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMRZ( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMRZ_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrz( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmrz_( const char* side, const char* trans, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUNMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void zunmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, const int* lwork, int* info ); void ZUPGTR( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZUPGTR_( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zupgtr( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void zupgtr_( const char* uplo, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, const int* ldq, MKL_Complex16* work, int* info ); void ZUPMTR( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void ZUPMTR_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zupmtr( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void zupmtr_( const char* side, const char* uplo, const char* trans, const int* m, const int* n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, const int* ldc, MKL_Complex16* work, int* info ); void CGEQRT2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CGEQRT2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt2( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void cgeqrt2_( const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* t, const int* ldt, int* info ); void CHESWAPR( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void CHESWAPR_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void cheswapr( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void cheswapr_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* i1, const int* i2 ); void CHETRI2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri2( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void chetri2_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* lwork, int* info ); void CHETRI2X( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CHETRI2X_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri2x( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void chetri2x_( const char* uplo, const int* n, MKL_Complex8* a, const int* lda, const int* ipiv, MKL_Complex8* work, const int* nb, int* info ); void CLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_GBRCOND_C( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GBRCOND_C_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_c( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_c_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GBRCOND_X( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_GBRCOND_X_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_x( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gbrcond_x_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); float CLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); float cla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); float cla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex8* ab, const int* ldab, const MKL_Complex8* afb, const int* ldafb ); void CLA_GEAMV( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_GEAMV_( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_geamv( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_geamv_( const int* trans, const int* m, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_GERCOND_C( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GERCOND_C_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_c( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_c_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_GERCOND_X( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_GERCOND_X_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_x( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_gercond_x_( const char* trans, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_GERPVGRW( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); float CLA_GERPVGRW_( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); float cla_gerpvgrw( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); float cla_gerpvgrw_( const int* n, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf ); void CLA_HEAMV( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_HEAMV_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_heamv( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_heamv_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_HERCOND_C( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_HERCOND_C_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_c( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_c_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_HERCOND_X( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_HERCOND_X_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_x( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_hercond_x_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_HERFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_HERFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_herfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_herfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_HERPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float CLA_HERPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_herpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_herpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); void CLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); void CLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); void cla_lin_berr( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); void cla_lin_berr_( const int* n, const int* nz, const int* nrhs, const MKL_Complex8* res, const float* ayb, float* berr ); float CLA_PORCOND_C( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_PORCOND_C_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_c( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_c_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_PORCOND_X( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_PORCOND_X_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_x( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_porcond_x_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_PORPVGRW( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); float CLA_PORPVGRW_( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); float cla_porpvgrw( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); float cla_porpvgrw_( const char* uplo, const int* ncols, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, float* work ); void CLA_SYAMV( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void CLA_SYAMV_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_syamv( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); void cla_syamv_( const int* uplo, const int* n, const float* alpha, const MKL_Complex8* a, const int* lda, const MKL_Complex8* x, const int* incx, const float* beta, float* y, const int* incy ); float CLA_SYRCOND_C( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_SYRCOND_C_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_c( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_c_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const float* c, const int* capply, int* info, MKL_Complex8* work, float* rwork ); float CLA_SYRCOND_X( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float CLA_SYRCOND_X_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_x( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); float cla_syrcond_x_( const char* uplo, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const MKL_Complex8* x, int* info, MKL_Complex8* work, float* rwork ); void CLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void CLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void cla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const MKL_Complex8* b, const int* ldb, MKL_Complex8* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, MKL_Complex8* res, float* ayb, MKL_Complex8* dy, MKL_Complex8* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float CLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float CLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_syrpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); float cla_syrpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex8* a, const int* lda, const MKL_Complex8* af, const int* ldaf, const int* ipiv, float* work ); void CLA_WWADDW( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void CLA_WWADDW_( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void cla_wwaddw( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void cla_wwaddw_( const int* n, MKL_Complex8* x, MKL_Complex8* y, const MKL_Complex8* w ); void CTPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void CTPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void ctprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void ctprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex8* v, const int* ldv, const MKL_Complex8* t, const int* ldt, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* work, const int* ldwork ); void DGEQRT2( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DGEQRT2_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt2( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void dgeqrt2_( const int* m, const int* n, double* a, const int* lda, double* t, const int* ldt, int* info ); void DLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void DLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const double* ab, const int* ldab, const double* x, const int* incx, const double* beta, double* y, const int* incy ); double DLA_GBRCOND( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_GBRCOND_( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gbrcond( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gbrcond_( const char* trans, const int* n, const int* kl, const int* ku, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const double* ab, const int* ldab, const double* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); double DLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); double dla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); double dla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const double* ab, const int* ldab, const double* afb, const int* ldafb ); void DLA_GEAMV( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void DLA_GEAMV_( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_geamv( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_geamv_( const int* trans, const int* m, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); double DLA_GERCOND( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_GERCOND_( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gercond( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_gercond_( const char* trans, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_GERPVGRW( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); double DLA_GERPVGRW_( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); double dla_gerpvgrw( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); double dla_gerpvgrw_( const int* n, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf ); void DLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); void DLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); void dla_lin_berr( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); void dla_lin_berr_( const int* n, const int* nz, const int* nrhs, const double* res, const double* ayb, double* berr ); double DLA_PORCOND( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_PORCOND_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_porcond( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_porcond_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_PORPVGRW( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); double DLA_PORPVGRW_( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); double dla_porpvgrw( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); double dla_porpvgrw_( const char* uplo, const int* ncols, const double* a, const int* lda, const double* af, const int* ldaf, double* work ); void DLA_SYAMV( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void DLA_SYAMV_( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_syamv( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); void dla_syamv_( const int* uplo, const int* n, const double* alpha, const double* a, const int* lda, const double* x, const int* incx, const double* beta, double* y, const int* incy ); double DLA_SYRCOND( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double DLA_SYRCOND_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_syrcond( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); double dla_syrcond_( const char* uplo, const int* n, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* cmode, const double* c, int* info, double* work, int* iwork ); void DLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void DLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void dla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const double* b, const int* ldb, double* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, double* res, double* ayb, double* dy, double* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double DLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); double DLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); double dla_syrpvgrw( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); double dla_syrpvgrw_( const char* uplo, const int* n, const int* info, const double* a, const int* lda, const double* af, const int* ldaf, const int* ipiv, double* work ); void DLA_WWADDW( const int* n, double* x, double* y, const double* w ); void DLA_WWADDW_( const int* n, double* x, double* y, const double* w ); void dla_wwaddw( const int* n, double* x, double* y, const double* w ); void dla_wwaddw_( const int* n, double* x, double* y, const double* w ); void DTPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void DTPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void dtprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void dtprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const double* v, const int* ldv, const double* t, const int* ldt, double* a, const int* lda, double* b, const int* ldb, double* work, const int* ldwork ); void SGEQRT2( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SGEQRT2_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt2( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void sgeqrt2_( const int* m, const int* n, float* a, const int* lda, float* t, const int* ldt, int* info ); void SLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void SLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const float* alpha, const float* ab, const int* ldab, const float* x, const int* incx, const float* beta, float* y, const int* incy ); float SLA_GBRCOND( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_GBRCOND_( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gbrcond( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gbrcond_( const char* trans, const int* n, const int* kl, const int* ku, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const float* ab, const int* ldab, const float* afb, const int* ldafb, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); float SLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); float sla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); float sla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const float* ab, const int* ldab, const float* afb, const int* ldafb ); void SLA_GEAMV( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void SLA_GEAMV_( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_geamv( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_geamv_( const int* trans, const int* m, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); float SLA_GERCOND( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_GERCOND_( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gercond( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_gercond_( const char* trans, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* errs_n, float* errs_c, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_GERPVGRW( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); float SLA_GERPVGRW_( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); float sla_gerpvgrw( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); float sla_gerpvgrw_( const int* n, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf ); void SLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); void SLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); void sla_lin_berr( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); void sla_lin_berr_( const int* n, const int* nz, const int* nrhs, const float* res, const float* ayb, float* berr ); float SLA_PORCOND( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_PORCOND_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_porcond( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_porcond_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_PORPVGRW( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); float SLA_PORPVGRW_( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); float sla_porpvgrw( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); float sla_porpvgrw_( const char* uplo, const int* ncols, const float* a, const int* lda, const float* af, const int* ldaf, float* work ); void SLA_SYAMV( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void SLA_SYAMV_( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_syamv( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); void sla_syamv_( const int* uplo, const int* n, const float* alpha, const float* a, const int* lda, const float* x, const int* incx, const float* beta, float* y, const int* incy ); float SLA_SYRCOND( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float SLA_SYRCOND_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_syrcond( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); float sla_syrcond_( const char* uplo, const int* n, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* cmode, const float* c, int* info, float* work, int* iwork ); void SLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void SLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); void sla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, const int* colequ, const float* c, const float* b, const int* ldb, float* y, const int* ldy, float* berr_out, const int* n_norms, float* err_bnds_norm, float* err_bnds_comp, float* res, float* ayb, float* dy, float* y_tail, const float* rcond, const int* ithresh, const float* rthresh, const float* dz_ub, const int* ignore_cwise, int* info ); float SLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); float SLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); float sla_syrpvgrw( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); float sla_syrpvgrw_( const char* uplo, const int* n, const int* info, const float* a, const int* lda, const float* af, const int* ldaf, const int* ipiv, float* work ); void SLA_WWADDW( const int* n, float* x, float* y, const float* w ); void SLA_WWADDW_( const int* n, float* x, float* y, const float* w ); void sla_wwaddw( const int* n, float* x, float* y, const float* w ); void sla_wwaddw_( const int* n, float* x, float* y, const float* w ); void STPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void STPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void stprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void stprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const float* v, const int* ldv, const float* t, const int* ldt, float* a, const int* lda, float* b, const int* ldb, float* work, const int* ldwork ); void ZGEQRT2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZGEQRT2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt2( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void zgeqrt2_( const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* t, const int* ldt, int* info ); void ZHESWAPR( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void ZHESWAPR_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zheswapr( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void zheswapr_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* i1, const int* i2 ); void ZHETRI2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri2( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void zhetri2_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* lwork, int* info ); void ZHETRI2X( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZHETRI2X_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri2x( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void zhetri2x_( const char* uplo, const int* n, MKL_Complex16* a, const int* lda, const int* ipiv, MKL_Complex16* work, const int* nb, int* info ); void ZLA_GBAMV( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_GBAMV_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_gbamv( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_gbamv_( const int* trans, const int* m, const int* n, const int* kl, const int* ku, const double* alpha, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_GBRCOND_C( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GBRCOND_C_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_c( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_c_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GBRCOND_X( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GBRCOND_X_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_x( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gbrcond_x_( const char* trans, const int* n, const int* kl, const int* ku, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_GBRFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_GBRFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gbrfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gbrfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* kl, const int* ku, const int* nrhs, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_GBRPVGRW( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); double ZLA_GBRPVGRW_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); double zla_gbrpvgrw( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); double zla_gbrpvgrw_( const int* n, const int* kl, const int* ku, const int* ncols, const MKL_Complex16* ab, const int* ldab, const MKL_Complex16* afb, const int* ldafb ); void ZLA_GEAMV( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_GEAMV_( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_geamv( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_geamv_( const int* trans, const int* m, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_GERCOND_C( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GERCOND_C_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_c( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_c_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GERCOND_X( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_GERCOND_X_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_x( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_gercond_x_( const char* trans, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_GERFSX_EXTENDED( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_GERFSX_EXTENDED_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gerfsx_extended( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_gerfsx_extended_( const int* prec_type, const int* trans_type, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* errs_n, double* errs_c, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_GERPVGRW( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); double ZLA_GERPVGRW_( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); double zla_gerpvgrw( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); double zla_gerpvgrw_( const int* n, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf ); void ZLA_HEAMV( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_HEAMV_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_heamv( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_heamv_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_HERCOND_C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_HERCOND_C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_HERCOND_X( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_HERCOND_X_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_x( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_hercond_x_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_HERFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_HERFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_herfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_herfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_HERPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double ZLA_HERPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_herpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_herpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); void ZLA_LIN_BERR( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); void ZLA_LIN_BERR_( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); void zla_lin_berr( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); void zla_lin_berr_( const int* n, const int* nz, const int* nrhs, const MKL_Complex16* res, const double* ayb, double* berr ); double ZLA_PORCOND_C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_PORCOND_C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_PORCOND_X( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_PORCOND_X_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_x( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_porcond_x_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_PORFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_PORFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_porfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_porfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_PORPVGRW( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); double ZLA_PORPVGRW_( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); double zla_porpvgrw( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); double zla_porpvgrw_( const char* uplo, const int* ncols, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, double* work ); void ZLA_SYAMV( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void ZLA_SYAMV_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_syamv( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); void zla_syamv_( const int* uplo, const int* n, const double* alpha, const MKL_Complex16* a, const int* lda, const MKL_Complex16* x, const int* incx, const double* beta, double* y, const int* incy ); double ZLA_SYRCOND_C( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_SYRCOND_C_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_c( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_c_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const double* c, const int* capply, int* info, MKL_Complex16* work, double* rwork ); double ZLA_SYRCOND_X( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double ZLA_SYRCOND_X_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_x( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); double zla_syrcond_x_( const char* uplo, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const MKL_Complex16* x, int* info, MKL_Complex16* work, double* rwork ); void ZLA_SYRFSX_EXTENDED( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void ZLA_SYRFSX_EXTENDED_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_syrfsx_extended( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); void zla_syrfsx_extended_( const int* prec_type, const char* uplo, const int* n, const int* nrhs, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, const int* colequ, const double* c, const MKL_Complex16* b, const int* ldb, MKL_Complex16* y, const int* ldy, double* berr_out, const int* n_norms, double* err_bnds_norm, double* err_bnds_comp, MKL_Complex16* res, double* ayb, MKL_Complex16* dy, MKL_Complex16* y_tail, const double* rcond, const int* ithresh, const double* rthresh, const double* dz_ub, const int* ignore_cwise, int* info ); double ZLA_SYRPVGRW( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double ZLA_SYRPVGRW_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_syrpvgrw( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); double zla_syrpvgrw_( const char* uplo, const int* n, const int* info, const MKL_Complex16* a, const int* lda, const MKL_Complex16* af, const int* ldaf, const int* ipiv, double* work ); void ZLA_WWADDW( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void ZLA_WWADDW_( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void zla_wwaddw( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void zla_wwaddw_( const int* n, MKL_Complex16* x, MKL_Complex16* y, const MKL_Complex16* w ); void ZTPRFB( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void ZTPRFB_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void ztprfb( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void ztprfb_( const char* side, const char* trans, const char* direct, const char* storev, const int* m, const int* n, const int* k, const int* l, const MKL_Complex16* v, const int* ldv, const MKL_Complex16* t, const int* ldt, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* work, const int* ldwork ); void CHERDB( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void CHERDB_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cherdb( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void cherdb_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex8* a, const int* lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* z, const int* ldz, MKL_Complex8* work, const int* lwork, int* info ); void DSYRDB( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void DSYRDB_( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsyrdb( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void dsyrdb_( const char* jobz, const char* uplo, const int* n, const int* kd, double* a, const int* lda, double* d, double* e, double* tau, double* z, const int* ldz, double* work, const int* lwork, int* info ); void SSYRDB( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void SSYRDB_( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssyrdb( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ssyrdb_( const char* jobz, const char* uplo, const int* n, const int* kd, float* a, const int* lda, float* d, float* e, float* tau, float* z, const int* ldz, float* work, const int* lwork, int* info ); void ZHERDB( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void ZHERDB_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zherdb( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void zherdb_( const char* jobz, const char* uplo, const int* n, const int* kd, MKL_Complex16* a, const int* lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* z, const int* ldz, MKL_Complex16* work, const int* lwork, int* info ); void CDTSVB( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CDTSVB_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdtsvb( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdtsvb_( const int* n, const int* nrhs, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CDTTRFB( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void CDTTRFB_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void cdttrfb( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void cdttrfb_( const int* n, MKL_Complex8* dl, MKL_Complex8* d, const MKL_Complex8* du, int* info ); void CDTTRSB( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void CDTTRSB_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdttrsb( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void cdttrsb_( const char* trans, const int* n, const int* nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* b, const int* ldb, int* info ); void DDTSVB( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void DDTSVB_( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void ddtsvb( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void ddtsvb_( const int* n, const int* nrhs, double* dl, double* d, const double* du, double* b, const int* ldb, int* info ); void DDTTRFB( const int* n, double* dl, double* d, const double* du, int* info ); void DDTTRFB_( const int* n, double* dl, double* d, const double* du, int* info ); void ddttrfb( const int* n, double* dl, double* d, const double* du, int* info ); void ddttrfb_( const int* n, double* dl, double* d, const double* du, int* info ); void DDTTRSB( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void DDTTRSB_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void ddttrsb( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void ddttrsb_( const char* trans, const int* n, const int* nrhs, const double* dl, const double* d, const double* du, double* b, const int* ldb, int* info ); void SDTSVB( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void SDTSVB_( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void sdtsvb( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void sdtsvb_( const int* n, const int* nrhs, float* dl, float* d, const float* du, float* b, const int* ldb, int* info ); void SDTTRFB( const int* n, float* dl, float* d, const float* du, int* info ); void SDTTRFB_( const int* n, float* dl, float* d, const float* du, int* info ); void sdttrfb( const int* n, float* dl, float* d, const float* du, int* info ); void sdttrfb_( const int* n, float* dl, float* d, const float* du, int* info ); void SDTTRSB( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void SDTTRSB_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void sdttrsb( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void sdttrsb_( const char* trans, const int* n, const int* nrhs, const float* dl, const float* d, const float* du, float* b, const int* ldb, int* info ); void ZDTSVB( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZDTSVB_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdtsvb( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdtsvb_( const int* n, const int* nrhs, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZDTTRFB( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void ZDTTRFB_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void zdttrfb( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void zdttrfb_( const int* n, MKL_Complex16* dl, MKL_Complex16* d, const MKL_Complex16* du, int* info ); void ZDTTRSB( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void ZDTTRSB_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdttrsb( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void zdttrsb_( const char* trans, const int* n, const int* nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* b, const int* ldb, int* info ); void MKL_CTPPACK( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void MKL_CTPPACK_( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void mkl_ctppack( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void mkl_ctppack_( const char* uplo, const char* trans, const int* n, MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex8* a, const int* lda, int* info ); void MKL_DTPPACK( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void MKL_DTPPACK_( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void mkl_dtppack( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void mkl_dtppack_( const char* uplo, const char* trans, const int* n, double* ap, const int* i, const int* j, const int* rows, const int* cols, const double* a, const int* lda, int* info ); void MKL_STPPACK( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void MKL_STPPACK_( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void mkl_stppack( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void mkl_stppack_( const char* uplo, const char* trans, const int* n, float* ap, const int* i, const int* j, const int* rows, const int* cols, const float* a, const int* lda, int* info ); void MKL_ZTPPACK( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void MKL_ZTPPACK_( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void mkl_ztppack( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void mkl_ztppack_( const char* uplo, const char* trans, const int* n, MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, const MKL_Complex16* a, const int* lda, int* info ); void MKL_CTPUNPACK( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void MKL_CTPUNPACK_( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void mkl_ctpunpack( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void mkl_ctpunpack_( const char* uplo, const char* trans, const int* n, const MKL_Complex8* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex8* a, const int* lda, int* info ); void MKL_DTPUNPACK( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void MKL_DTPUNPACK_( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void mkl_dtpunpack( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void mkl_dtpunpack_( const char* uplo, const char* trans, const int* n, const double* ap, const int* i, const int* j, const int* rows, const int* cols, double* a, const int* lda, int* info ); void MKL_STPUNPACK( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void MKL_STPUNPACK_( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void mkl_stpunpack( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void mkl_stpunpack_( const char* uplo, const char* trans, const int* n, const float* ap, const int* i, const int* j, const int* rows, const int* cols, float* a, const int* lda, int* info ); void MKL_ZTPUNPACK( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void MKL_ZTPUNPACK_( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void mkl_ztpunpack( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void mkl_ztpunpack_( const char* uplo, const char* trans, const int* n, const MKL_Complex16* ap, const int* i, const int* j, const int* rows, const int* cols, MKL_Complex16* a, const int* lda, int* info ); void DLATM1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void DLATM1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void dlatm1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void dlatm1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, double* d, const int* n, int* info ); void SLATM1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void SLATM1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void slatm1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void slatm1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, float* d, const int* n, int* info ); void CLATM1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void CLATM1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void clatm1( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void clatm1_( const int* mode, const float* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex8* d, const int* n, int* info ); void ZLATM1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); void ZLATM1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); void zlatm1( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); void zlatm1_( const int* mode, const double* cond, const int* irsign, const int* idist, int* iseed, MKL_Complex16* d, const int* n, int* info ); double DLATM2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); double DLATM2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); double dlatm2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); double dlatm2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, int* iwork, const double* sparse ); float SLATM2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); float SLATM2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); float slatm2( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); float slatm2_( const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, int* iwork, const float* sparse ); void CLATM2( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void CLATM2_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void clatm2( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void clatm2_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, int* iwork, const float* sparse ); void ZLATM2( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); void ZLATM2_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); void zlatm2( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); void zlatm2_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, int* iwork, const double* sparse ); double DLATM3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); double DLATM3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); double dlatm3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); double dlatm3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const double* d, const int* igrade, const double* dl, const double* dr, const int* ipvtng, const int* iwork, const double* sparse ); float SLATM3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); float SLATM3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); float slatm3( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); float slatm3_( const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const float* d, const int* igrade, const float* dl, const float* dr, const int* ipvtng, const int* iwork, const float* sparse ); void CLATM3( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void CLATM3_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void clatm3( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void clatm3_( MKL_Complex8* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex8* d, const int* igrade, const MKL_Complex8* dl, const MKL_Complex8* dr, const int* ipvtng, const int* iwork, const float* sparse ); void ZLATM3( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void ZLATM3_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void zlatm3( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void zlatm3_( MKL_Complex16* retval, const int* m, const int* n, int* ii, const int* j, int* isub, int* jsub, const int* kl, const int* ku, const int* idist, int* iseed, const MKL_Complex16* d, const int* igrade, const MKL_Complex16* dl, const MKL_Complex16* dr, const int* ipvtng, const int* iwork, const double* sparse ); void DLATM5( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void DLATM5_( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void dlatm5( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void dlatm5_( const int* prtype, const int* m, const int* n, double* a, const int* lda, double* b, const int* ldb, double* c, const int* ldc, double* d, const int* ldd, double* e, const int* lde, double* f, const int* ldf, double* r, const int* ldr, double* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void SLATM5( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void SLATM5_( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void slatm5( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void slatm5_( const int* prtype, const int* m, const int* n, float* a, const int* lda, float* b, const int* ldb, float* c, const int* ldc, float* d, const int* ldd, float* e, const int* lde, float* f, const int* ldf, float* r, const int* ldr, float* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void CLATM5( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void CLATM5_( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void clatm5( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void clatm5_( const int* prtype, const int* m, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, const int* ldb, MKL_Complex8* c, const int* ldc, MKL_Complex8* d, const int* ldd, MKL_Complex8* e, const int* lde, MKL_Complex8* f, const int* ldf, MKL_Complex8* r, const int* ldr, MKL_Complex8* l, const int* ldl, const float* alpha, const int* qblcka, const int* qblckb ); void ZLATM5( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void ZLATM5_( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void zlatm5( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void zlatm5_( const int* prtype, const int* m, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, const int* ldb, MKL_Complex16* c, const int* ldc, MKL_Complex16* d, const int* ldd, MKL_Complex16* e, const int* lde, MKL_Complex16* f, const int* ldf, MKL_Complex16* r, const int* ldr, MKL_Complex16* l, const int* ldl, const double* alpha, const int* qblcka, const int* qblckb ); void DLATM6( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void DLATM6_( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void dlatm6( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void dlatm6_( const int* type, const int* n, double* a, const int* lda, double* b, double* x, const int* ldx, double* y, const int* ldy, const double* alpha, const double* beta, const double* wx, const double* wy, double* s, double* dif ); void SLATM6( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void SLATM6_( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void slatm6( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void slatm6_( const int* type, const int* n, float* a, const int* lda, float* b, float* x, const int* ldx, float* y, const int* ldy, const float* alpha, const float* beta, const float* wx, const float* wy, float* s, float* dif ); void CLATM6( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void CLATM6_( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void clatm6( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void clatm6_( const int* type, const int* n, MKL_Complex8* a, const int* lda, MKL_Complex8* b, MKL_Complex8* x, const int* ldx, MKL_Complex8* y, const int* ldy, const MKL_Complex8* alpha, const MKL_Complex8* beta, const MKL_Complex8* wx, const MKL_Complex8* wy, float* s, float* dif ); void ZLATM6( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void ZLATM6_( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void zlatm6( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void zlatm6_( const int* type, const int* n, MKL_Complex16* a, const int* lda, MKL_Complex16* b, MKL_Complex16* x, const int* ldx, MKL_Complex16* y, const int* ldy, const MKL_Complex16* alpha, const MKL_Complex16* beta, const MKL_Complex16* wx, const MKL_Complex16* wy, double* s, double* dif ); void DLATME( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void DLATME_( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void dlatme( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void dlatme_( const int* n, const char* dist, int* iseed, double* d, const int* mode, const double* cond, const double* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, double* a, const int* lda, double* work, int* info ); void SLATME( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void SLATME_( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void slatme( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void slatme_( const int* n, const char* dist, int* iseed, float* d, const int* mode, const float* cond, const float* dmax, const char* ei, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, float* a, const int* lda, float* work, int* info ); void CLATME( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void CLATME_( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatme( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatme_( const int* n, const char* dist, int* iseed, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* upper, const char* sim, float* ds, const int* modes, const float* conds, const int* kl, const int* ku, const float* anorm, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void ZLATME( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void ZLATME_( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatme( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatme_( const int* n, const char* dist, int* iseed, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* upper, const char* sim, double* ds, const int* modes, const double* conds, const int* kl, const int* ku, const double* anorm, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void DLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void DLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void dlatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void dlatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const char* rsign, const char* grade, double* dl, const int* model, const double* condl, double* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, double* a, const int* lda, int* iwork, int* info ); void SLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void SLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void slatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void slatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, const float* d, const int* mode, const float* cond, const float* dmax, const char* rsign, const char* grade, float* dl, const int* model, const float* condl, float* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, float* a, const int* lda, int* iwork, int* info ); void CLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void CLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void clatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void clatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex8* d, const int* mode, const float* cond, const MKL_Complex8* dmax, const char* rsign, const char* grade, MKL_Complex8* dl, const int* model, const float* condl, MKL_Complex8* dr, const int* moder, const float* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const float* sparse, const float* anorm, const char* pack, MKL_Complex8* a, const int* lda, int* iwork, int* info ); void ZLATMR( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void ZLATMR_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void zlatmr( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void zlatmr_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, MKL_Complex16* d, const int* mode, const double* cond, const MKL_Complex16* dmax, const char* rsign, const char* grade, MKL_Complex16* dl, const int* model, const double* condl, MKL_Complex16* dr, const int* moder, const double* condr, const char* pivtng, const int* ipivot, const int* kl, const int* ku, const double* sparse, const double* anorm, const char* pack, MKL_Complex16* a, const int* lda, int* iwork, int* info ); void DLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void DLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void dlatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void dlatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, double* a, const int* lda, double* work, int* info ); void SLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void SLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void slatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void slatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, float* a, const int* lda, float* work, int* info ); void CLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void CLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void clatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, float* d, const int* mode, const float* cond, const float* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex8* a, const int* lda, MKL_Complex8* work, int* info ); void ZLATMS( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void ZLATMS_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatms( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void zlatms_( const int* m, const int* n, const char* dist, int* iseed, const char* sym, double* d, const int* mode, const double* cond, const double* dmax, const int* kl, const int* ku, const char* pack, MKL_Complex16* a, const int* lda, MKL_Complex16* work, int* info ); void DLAKF2( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void DLAKF2_( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void dlakf2( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void dlakf2_( const int* m, const int* n, const double* a, const int* lda, const double* b, const double* d, const double* e, double* z, const int* ldz ); void SLAKF2( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void SLAKF2_( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void slakf2( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void slakf2_( const int* m, const int* n, const float* a, const int* lda, const float* b, const float* d, const float* e, float* z, const int* ldz ); void CLAKF2( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void CLAKF2_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void clakf2( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void clakf2_( const int* m, const int* n, const MKL_Complex8* a, const int* lda, const MKL_Complex8* b, const MKL_Complex8* d, const MKL_Complex8* e, MKL_Complex8* z, const int* ldz ); void ZLAKF2( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void ZLAKF2_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void zlakf2( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void zlakf2_( const int* m, const int* n, const MKL_Complex16* a, const int* lda, const MKL_Complex16* b, const MKL_Complex16* d, const MKL_Complex16* e, MKL_Complex16* z, const int* ldz ); void DLARGE( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void DLARGE_( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void dlarge( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void dlarge_( const int* n, double* a, const int* lda, int* iseed, double* work, int* info ); void SLARGE( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void SLARGE_( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void slarge( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void slarge_( const int* n, float* a, const int* lda, int* iseed, float* work, int* info ); void CLARGE( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLARGE_( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clarge( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clarge_( const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void ZLARGE( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLARGE_( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlarge( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlarge_( const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); double DLARND( const int* idist, int* iseed ); double DLARND_( const int* idist, int* iseed ); double dlarnd( const int* idist, int* iseed ); double dlarnd_( const int* idist, int* iseed ); float SLARND( const int* idist, int* iseed ); float SLARND_( const int* idist, int* iseed ); float slarnd( const int* idist, int* iseed ); float slarnd_( const int* idist, int* iseed ); void CLARND( MKL_Complex8* retval, const int* idist, int* iseed ); void CLARND_( MKL_Complex8* retval, const int* idist, int* iseed ); void clarnd( MKL_Complex8* retval, const int* idist, int* iseed ); void clarnd_( MKL_Complex8* retval, const int* idist, int* iseed ); void ZLARND( MKL_Complex16* retval, const int* idist, int* iseed ); void ZLARND_( MKL_Complex16* retval, const int* idist, int* iseed ); void zlarnd( MKL_Complex16* retval, const int* idist, int* iseed ); void zlarnd_( MKL_Complex16* retval, const int* idist, int* iseed ); void DLAROR( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void DLAROR_( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void dlaror( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void dlaror_( const char* side, const char* init, const int* m, const int* n, double* a, const int* lda, int* iseed, double* x, int* info ); void SLAROR( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void SLAROR_( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void slaror( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void slaror_( const char* side, const char* init, const int* m, const int* n, float* a, const int* lda, int* iseed, float* x, int* info ); void CLAROR( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void CLAROR_( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void claror( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void claror_( const char* side, const char* init, const int* m, const int* n, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* x, int* info ); void ZLAROR( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void ZLAROR_( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void zlaror( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void zlaror_( const char* side, const char* init, const int* m, const int* n, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* x, int* info ); void DLAROT( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void DLAROT_( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void dlarot( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void dlarot_( const int* lrows, const int* lleft, const int* lright, const int* nl, const double* c, const double* s, double* a, const int* lda, double* xleft, double* xright ); void SLAROT( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void SLAROT_( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void slarot( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void slarot_( const int* lrows, const int* lleft, const int* lright, const int* nl, const float* c, const float* s, float* a, const int* lda, float* xleft, float* xright ); void CLAROT( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void CLAROT_( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void clarot( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void clarot_( const int* lrows, const int* lleft, int* lright, const int* nl, const MKL_Complex8* c, const MKL_Complex8* s, MKL_Complex8* a, const int* lda, MKL_Complex8* xleft, MKL_Complex8* xright ); void ZLAROT( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); void ZLAROT_( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); void zlarot( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); void zlarot_( const int* lrows, const int* lleft, const int* lright, const int* nl, const MKL_Complex16* c, const MKL_Complex16* s, MKL_Complex16* a, const int* lda, MKL_Complex16* xleft, MKL_Complex16* xright ); double DLARAN( int* iseed ); double DLARAN_( int* iseed ); double dlaran( int* iseed ); double dlaran_( int* iseed ); float SLARAN( int* iseed ); float SLARAN_( int* iseed ); float slaran( int* iseed ); float slaran_( int* iseed ); void DLAGGE( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void DLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagge( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagge_( const int* m, const int* n, const int* kl, const int* ku, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void SLAGGE( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void SLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagge( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagge_( const int* m, const int* n, const int* kl, const int* ku, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void CLAGGE( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagge( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagge_( const int* m, const int* n, const int* kl, const int* ku, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void ZLAGGE( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLAGGE_( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagge( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagge_( const int* m, const int* n, const int* kl, const int* ku, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void CLAGSY( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLAGSY_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagsy( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void clagsy_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void DLAGSY( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void DLAGSY_( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagsy( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void dlagsy_( const int* n, const int* k, const double* d, double* a, const int* lda, int* iseed, double* work, int* info ); void SLAGSY( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void SLAGSY_( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagsy( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void slagsy_( const int* n, const int* k, const float* d, float* a, const int* lda, int* iseed, float* work, int* info ); void ZLAGSY( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLAGSY_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagsy( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlagsy_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void CLAGHE( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void CLAGHE_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void claghe( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void claghe_( const int* n, const int* k, const float* d, MKL_Complex8* a, const int* lda, int* iseed, MKL_Complex8* work, int* info ); void ZLAGHE( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void ZLAGHE_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlaghe( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void zlaghe_( const int* n, const int* k, const double* d, MKL_Complex16* a, const int* lda, int* iseed, MKL_Complex16* work, int* info ); void MKL_CSPFFRT2( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrt2( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrt2_( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void MKL_CSPFFRTX( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrtx( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void mkl_cspffrtx_( MKL_Complex8 *ap, const int *n, const int *ncolm, MKL_Complex8 *work, MKL_Complex8 *work2 ); void MKL_DSPFFRT2( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrt2( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrt2_( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void MKL_DSPFFRTX( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrtx( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void mkl_dspffrtx_( double *ap, const int *n, const int *ncolm, double *work, double *work2 ); void MKL_SSPFFRT2( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrt2( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrt2_( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void MKL_SSPFFRTX( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrtx( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void mkl_sspffrtx_( float *ap, const int *n, const int *ncolm, float *work, float *work2 ); void MKL_ZSPFFRT2( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrt2( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrt2_( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void MKL_ZSPFFRTX( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrtx( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); void mkl_zspffrtx_( MKL_Complex16 *ap, const int *n, const int *ncolm, MKL_Complex16 *work, MKL_Complex16 *work2 ); int MKL_PROGRESS( int* thread, int* step, char* stage, int lstage ); int MKL_PROGRESS_( int* thread, int* step, char* stage, int lstage ); int mkl_progress( int* thread, int* step, char* stage, int lstage ); int mkl_progress_( int* thread, int* step, char* stage, int lstage ); #line 44 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_lapacke.h" typedef int (*LAPACK_S_SELECT2) ( const float*, const float* ); typedef int (*LAPACK_S_SELECT3) ( const float*, const float*, const float* ); typedef int (*LAPACK_D_SELECT2) ( const double*, const double* ); typedef int (*LAPACK_D_SELECT3) ( const double*, const double*, const double* ); typedef int (*LAPACK_C_SELECT1) ( const MKL_Complex8* ); typedef int (*LAPACK_C_SELECT2) ( const MKL_Complex8*, const MKL_Complex8* ); typedef int (*LAPACK_Z_SELECT1) ( const MKL_Complex16* ); typedef int (*LAPACK_Z_SELECT2) ( const MKL_Complex16*, const MKL_Complex16* ); double LAPACKE_dlamch( char cmach ); double LAPACKE_dlamch_work( char cmach ); double LAPACKE_dlange( int matrix_layout, char norm, int m, int n, const double* a, int lda ); double LAPACKE_dlange_work( int matrix_layout, char norm, int m, int n, const double* a, int lda, double* work ); double LAPACKE_dlansy( int matrix_layout, char norm, char uplo, int n, const double* a, int lda ); double LAPACKE_dlansy_work( int matrix_layout, char norm, char uplo, int n, const double* a, int lda, double* work ); double LAPACKE_dlantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const double* a, int lda ); double LAPACKE_dlantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const double* a, int lda, double* work ); double LAPACKE_dlapy2( double x, double y ); double LAPACKE_dlapy2_work( double x, double y ); double LAPACKE_dlapy3( double x, double y, double z ); double LAPACKE_dlapy3_work( double x, double y, double z ); double LAPACKE_zlange( int matrix_layout, char norm, int m, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlange_work( int matrix_layout, char norm, int m, int n, const MKL_Complex16* a, int lda, double* work ); double LAPACKE_zlanhe( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlanhe_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda, double* work ); int LAPACKE_zlarcm( int matrix_layout, int m, int n, const double* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc ); int LAPACKE_zlarcm_work( int matrix_layout, int m, int n, const double* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, double* work ); int LAPACKE_zlacrm( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, const double* b, int ldb, MKL_Complex16* c, int ldc ); int LAPACKE_zlacrm_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, const double* b, int ldb, MKL_Complex16* c, int ldc, double* work ); double LAPACKE_zlansy( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlansy_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex16* a, int lda, double* work ); double LAPACKE_zlantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex16* a, int lda ); double LAPACKE_zlantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex16* a, int lda, double* work ); float LAPACKE_clange( int matrix_layout, char norm, int m, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clange_work( int matrix_layout, char norm, int m, int n, const MKL_Complex8* a, int lda, float* work ); float LAPACKE_clanhe( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clanhe_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda, float* work ); int LAPACKE_clarcm( int matrix_layout, int m, int n, const float* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc ); int LAPACKE_clarcm_work( int matrix_layout, int m, int n, const float* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, float* rwork ); int LAPACKE_clacrm( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, const float* b, int ldb, MKL_Complex8* c, int ldc ); int LAPACKE_clacrm_work( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, const float* b, int ldb, MKL_Complex8* c, int ldc, float* rwork ); float LAPACKE_clansy( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clansy_work( int matrix_layout, char norm, char uplo, int n, const MKL_Complex8* a, int lda, float* work ); float LAPACKE_clantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex8* a, int lda ); float LAPACKE_clantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const MKL_Complex8* a, int lda, float* work ); float LAPACKE_slamch( char cmach ); float LAPACKE_slamch_work( char cmach ); float LAPACKE_slange( int matrix_layout, char norm, int m, int n, const float* a, int lda ); float LAPACKE_slange_work( int matrix_layout, char norm, int m, int n, const float* a, int lda, float* work ); float LAPACKE_slansy( int matrix_layout, char norm, char uplo, int n, const float* a, int lda ); float LAPACKE_slansy_work( int matrix_layout, char norm, char uplo, int n, const float* a, int lda, float* work ); float LAPACKE_slantr( int matrix_layout, char norm, char uplo, char diag, int m, int n, const float* a, int lda ); float LAPACKE_slantr_work( int matrix_layout, char norm, char uplo, char diag, int m, int n, const float* a, int lda, float* work ); float LAPACKE_slapy2( float x, float y ); float LAPACKE_slapy2_work( float x, float y ); float LAPACKE_slapy3( float x, float y, float z ); float LAPACKE_slapy3_work( float x, float y, float z ); int LAPACKE_cbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e ); int LAPACKE_cbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* rwork, int lrwork ); int LAPACKE_cbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, MKL_Complex8* vt, int ldvt, MKL_Complex8* u, int ldu, MKL_Complex8* c, int ldc ); int LAPACKE_cbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, MKL_Complex8* vt, int ldvt, MKL_Complex8* u, int ldu, MKL_Complex8* c, int ldc, float* work ); int LAPACKE_cgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq, MKL_Complex8* pt, int ldpt, MKL_Complex8* c, int ldc ); int LAPACKE_cgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq, MKL_Complex8* pt, int ldpt, MKL_Complex8* c, int ldc, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbcon( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, const int* ipiv, float anorm, float* rcond ); int LAPACKE_cgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbequ( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbequb( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex8* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_cgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgbtrf( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex8* ab, int ldab, int* ipiv ); int LAPACKE_cgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex8* ab, int ldab, int* ipiv ); int LAPACKE_cgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex8* ab, int ldab, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cgebal( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_cgebal_work( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_cgebrd( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup ); int LAPACKE_cgebrd_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tauq, MKL_Complex8* taup, MKL_Complex8* work, int lwork ); int LAPACKE_cgecon( int matrix_layout, char norm, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond ); int LAPACKE_cgecon_work( int matrix_layout, char norm, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cgeequ( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgeequ_work( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgeequb( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgeequb_work( int matrix_layout, int m, int n, const MKL_Complex8* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_cgees( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs ); int LAPACKE_cgees_work( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cgeesx( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, char sense, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs, float* rconde, float* rcondv ); int LAPACKE_cgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_C_SELECT1 select, char sense, int n, MKL_Complex8* a, int lda, int* sdim, MKL_Complex8* w, MKL_Complex8* vs, int ldvs, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cgeev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr ); int LAPACKE_cgeev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv ); int LAPACKE_cgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgehrd( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgehrd_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex8* a, int lda, float* sva, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, float* stat, int* istat ); int LAPACKE_cgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex8* a, int lda, float* sva, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* cwork, int lwork, float* rwork, int lrwork, int* iwork ); int LAPACKE_cgelq2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgelq2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work ); int LAPACKE_cgelqf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgelqf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgels( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cgels_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_cgelsd( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_cgelsd_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cgelss( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_cgelss_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* s, float rcond, int* rank, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgelsy( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* jpvt, float rcond, int* rank ); int LAPACKE_cgelsy_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* jpvt, float rcond, int* rank, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc ); int LAPACKE_cgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_cgeqlf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqlf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqp3( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau ); int LAPACKE_cgeqp3_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgeqpf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau ); int LAPACKE_cgeqpf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* jpvt, MKL_Complex8* tau, MKL_Complex8* work, float* rwork ); int LAPACKE_cgeqr2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqr2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work ); int LAPACKE_cgeqrf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqrf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqrfp( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgeqrfp_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqrt( int matrix_layout, int m, int n, int nb, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt3( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt3_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt ); int LAPACKE_cgeqrt_work( int matrix_layout, int m, int n, int nb, MKL_Complex8* a, int lda, MKL_Complex8* t, int ldt, MKL_Complex8* work ); int LAPACKE_cgerfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cgerfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* r, const float* c, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgerqf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_cgerqf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cgesdd( int matrix_layout, char jobz, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt ); int LAPACKE_cgesdd_work( int matrix_layout, char jobz, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cgesv( int matrix_layout, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgesv_work( int matrix_layout, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, float* superb ); int LAPACKE_cgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex8* a, int lda, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, int* superb ); int LAPACKE_cgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, MKL_Complex8* u, int ldu, MKL_Complex8* vt, int ldvt, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex8 * a, int lda, float* sva, int mv, MKL_Complex8* v, int ldv, float* stat ); int LAPACKE_cgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex8* a, int lda, float* sva, int mv, MKL_Complex8* v, int ldv, MKL_Complex8* cwork, int lwork, float* rwork, int lrwork ); int LAPACKE_cgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_cgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* r, float* c, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cgetf2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetf2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf2( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf2_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetrf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_cgetri( int matrix_layout, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_cgetri_work( int matrix_layout, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_cgetrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgetrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, MKL_Complex8* v, int ldv ); int LAPACKE_cggbal( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale ); int LAPACKE_cggbal_work( int matrix_layout, char job, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work ); int LAPACKE_cgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr ); int LAPACKE_cgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr ); int LAPACKE_cgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, MKL_Complex8* work, int lwork, float* rwork, int* bwork ); int LAPACKE_cggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, float* rconde, float* rcondv ); int LAPACKE_cggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_C_SELECT2 selctg, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, int* sdim, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vsl, int ldvsl, MKL_Complex8* vsr, int ldvsr, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int liwork, int* bwork ); int LAPACKE_cggev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr ); int LAPACKE_cggev3( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr ); int LAPACKE_cggev3_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cggev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv ); int LAPACKE_cggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* bwork ); int LAPACKE_cggglm( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y ); int LAPACKE_cggglm_work( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* y, MKL_Complex8* work, int lwork ); int LAPACKE_cgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_cgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork ); int LAPACKE_cgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_cgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_cgglse( int matrix_layout, int m, int n, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x ); int LAPACKE_cgglse_work( int matrix_layout, int m, int n, int p, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* c, MKL_Complex8* d, MKL_Complex8* x, MKL_Complex8* work, int lwork ); int LAPACKE_cggqrf( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub ); int LAPACKE_cggqrf_work( int matrix_layout, int n, int m, int p, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub, MKL_Complex8* work, int lwork ); int LAPACKE_cggrqf( int matrix_layout, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub ); int LAPACKE_cggrqf_work( int matrix_layout, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* taua, MKL_Complex8* b, int ldb, MKL_Complex8* taub, MKL_Complex8* work, int lwork ); int LAPACKE_cggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork ); int LAPACKE_cggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork ); int LAPACKE_cggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, MKL_Complex8* work, int lwork, float* rwork, int* iwork ); int LAPACKE_cggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, MKL_Complex8* work, float* rwork, int* iwork ); int LAPACKE_cggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq ); int LAPACKE_cggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq ); int LAPACKE_cggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, int* k, int* l, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* iwork, float* rwork, MKL_Complex8* tau, MKL_Complex8* work ); int LAPACKE_cgtcon( char norm, int n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, float anorm, float* rcond ); int LAPACKE_cgtcon_work( char norm, int n, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_cgtrfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* dlf, const MKL_Complex8* df, const MKL_Complex8* duf, const MKL_Complex8* du2, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgtsv( int matrix_layout, int n, int nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, int ldb ); int LAPACKE_cgtsv_work( int matrix_layout, int n, int nrhs, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* b, int ldb ); int LAPACKE_cgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, MKL_Complex8* dlf, MKL_Complex8* df, MKL_Complex8* duf, MKL_Complex8* du2, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cgttrf( int n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv ); int LAPACKE_cgttrf_work( int n, MKL_Complex8* dl, MKL_Complex8* d, MKL_Complex8* du, MKL_Complex8* du2, int* ipiv ); int LAPACKE_cgttrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cgttrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex8* dl, const MKL_Complex8* d, const MKL_Complex8* du, const MKL_Complex8* du2, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chbev( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chbevd( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, const MKL_Complex8* bb, int ldbb, MKL_Complex8* x, int ldx ); int LAPACKE_chbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, const MKL_Complex8* bb, int ldbb, MKL_Complex8* x, int ldx, MKL_Complex8* work, float* rwork ); int LAPACKE_chbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex8* ab, int ldab, MKL_Complex8* bb, int ldbb, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chbtrd( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq ); int LAPACKE_chbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* d, float* e, MKL_Complex8* q, int ldq, MKL_Complex8* work ); int LAPACKE_checon( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond ); int LAPACKE_checon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_cheequb( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cheequb_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax, MKL_Complex8* work ); int LAPACKE_cheev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cheevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevr( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz ); int LAPACKE_cheevr_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_cheevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_chegst( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb ); int LAPACKE_chegst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb ); int LAPACKE_chegv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w ); int LAPACKE_chegv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chegvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w ); int LAPACKE_chegvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chegvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chegvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_cherfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cherfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cherfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cherfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_chesv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chesv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_chesvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_chesvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chesvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_chesvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cheswapr( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_cheswapr_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_chetrd( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tau ); int LAPACKE_chetrd_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, float* d, float* e, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_chetrf_rook( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_chetrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetri( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_chetri2( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_chetri2_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetri2x( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, int nb ); int LAPACKE_chetri2x_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int nb ); int LAPACKE_chetri_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work ); int LAPACKE_chetrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work ); int LAPACKE_chetrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const MKL_Complex8* a, int lda, float beta, MKL_Complex8* c ); int LAPACKE_chfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const MKL_Complex8* a, int lda, float beta, MKL_Complex8* c ); int LAPACKE_chgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* t, int ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz ); int LAPACKE_chgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* t, int ldt, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chpcon( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond ); int LAPACKE_chpcon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_chpev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chpevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* ap, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chpevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chpevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chpgst( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* ap, const MKL_Complex8* bp ); int LAPACKE_chpgst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex8* ap, const MKL_Complex8* bp ); int LAPACKE_chpgv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork ); int LAPACKE_chpgvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chpgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chpgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chpgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex8* ap, MKL_Complex8* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, float* rwork, int* iwork, int* ifail ); int LAPACKE_chprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_chprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_chpsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chpsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chpsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_chpsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_chptrd( int matrix_layout, char uplo, int n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau ); int LAPACKE_chptrd_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, float* d, float* e, MKL_Complex8* tau ); int LAPACKE_chptrf( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_chptrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_chptri( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv ); int LAPACKE_chptri_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work ); int LAPACKE_chptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chsein( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_chsein_work( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, MKL_Complex8* work, float* rwork, int* ifaill, int* ifailr ); int LAPACKE_chseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* z, int ldz ); int LAPACKE_chseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex8* h, int ldh, MKL_Complex8* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork ); int LAPACKE_clacgv( int n, MKL_Complex8* x, int incx ); int LAPACKE_clacgv_work( int n, MKL_Complex8* x, int incx ); int LAPACKE_clacn2( int n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); int LAPACKE_clacn2_work( int n, MKL_Complex8* v, MKL_Complex8* x, float* est, int* kase, int* isave ); int LAPACKE_clacp2( int matrix_layout, char uplo, int m, int n, const float* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clacp2_work( int matrix_layout, char uplo, int m, int n, const float* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clacpy( int matrix_layout, char uplo, int m, int n, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clacpy_work( int matrix_layout, char uplo, int m, int n, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_clag2z( int matrix_layout, int m, int n, const MKL_Complex8* sa, int ldsa, MKL_Complex16* a, int lda ); int LAPACKE_clag2z_work( int matrix_layout, int m, int n, const MKL_Complex8* sa, int ldsa, MKL_Complex16* a, int lda ); int LAPACKE_clagge( int matrix_layout, int m, int n, int kl, int ku, const float* d, MKL_Complex8* a, int lda, int* iseed ); int LAPACKE_clagge_work( int matrix_layout, int m, int n, int kl, int ku, const float* d, MKL_Complex8* a, int lda, int* iseed, MKL_Complex8* work ); int LAPACKE_claghe( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed ); int LAPACKE_claghe_work( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed, MKL_Complex8* work ); int LAPACKE_clagsy( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed ); int LAPACKE_clagsy_work( int matrix_layout, int n, int k, const float* d, MKL_Complex8* a, int lda, int* iseed, MKL_Complex8* work ); int LAPACKE_clapmr( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clapmr_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clapmt( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clapmt_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex8* x, int ldx, int* k ); int LAPACKE_clarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc ); int LAPACKE_clarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* c, int ldc, MKL_Complex8* work, int ldwork ); int LAPACKE_clarfg( int n, MKL_Complex8* alpha, MKL_Complex8* x, int incx, MKL_Complex8* tau ); int LAPACKE_clarfg_work( int n, MKL_Complex8* alpha, MKL_Complex8* x, int incx, MKL_Complex8* tau ); int LAPACKE_clarft( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* tau, MKL_Complex8* t, int ldt ); int LAPACKE_clarft_work( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex8* v, int ldv, const MKL_Complex8* tau, MKL_Complex8* t, int ldt ); int LAPACKE_clarfx( int matrix_layout, char side, int m, int n, const MKL_Complex8* v, MKL_Complex8 tau, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_clarfx_work( int matrix_layout, char side, int m, int n, const MKL_Complex8* v, MKL_Complex8 tau, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_clarnv( int idist, int* iseed, int n, MKL_Complex8* x ); int LAPACKE_clarnv_work( int idist, int* iseed, int n, MKL_Complex8* x ); int LAPACKE_clascl( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_clascl_work( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_claset( int matrix_layout, char uplo, int m, int n, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8* a, int lda ); int LAPACKE_claset_work( int matrix_layout, char uplo, int m, int n, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8* a, int lda ); int LAPACKE_claswp( int matrix_layout, int n, MKL_Complex8* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_claswp_work( int matrix_layout, int n, MKL_Complex8* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_clatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, MKL_Complex8* a, int lda ); int LAPACKE_clatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, MKL_Complex8* a, int lda, MKL_Complex8* work ); int LAPACKE_clauum( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_clauum_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpbcon( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float anorm, float* rcond ); int LAPACKE_cpbcon_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cpbequ( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_cpbequ_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex8* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_cpbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cpbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* afb, int ldafb, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpbstf( int matrix_layout, char uplo, int n, int kb, MKL_Complex8* bb, int ldbb ); int LAPACKE_cpbstf_work( int matrix_layout, char uplo, int n, int kb, MKL_Complex8* bb, int ldbb ); int LAPACKE_cpbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cpbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex8* ab, int ldab, MKL_Complex8* afb, int ldafb, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpbtrf( int matrix_layout, char uplo, int n, int kd, MKL_Complex8* ab, int ldab ); int LAPACKE_cpbtrf_work( int matrix_layout, char uplo, int n, int kd, MKL_Complex8* ab, int ldab ); int LAPACKE_cpbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_cpftrf( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftrf_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftri( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftri_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex8* a ); int LAPACKE_cpftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_cpftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_cpocon( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond ); int LAPACKE_cpocon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cpoequ( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cpoequ_work( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cpoequb( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cpoequb_work( int matrix_layout, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_cporfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cporfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cposv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cposv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_cposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_cpotrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrf2( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrf2_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotri( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotri_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda ); int LAPACKE_cpotrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cpotrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cppcon( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float anorm, float* rcond ); int LAPACKE_cppcon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float anorm, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_cppequ( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float* s, float* scond, float* amax ); int LAPACKE_cppequ_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, float* s, float* scond, float* amax ); int LAPACKE_cpprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cpprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cppsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cppsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* ap, MKL_Complex8* afp, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpptrf( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptri( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptri_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap ); int LAPACKE_cpptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cpptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_cpstrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* piv, int* rank, float tol ); int LAPACKE_cpstrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* piv, int* rank, float tol, float* work ); int LAPACKE_cptcon( int n, const float* d, const MKL_Complex8* e, float anorm, float* rcond ); int LAPACKE_cptcon_work( int n, const float* d, const MKL_Complex8* e, float anorm, float* rcond, float* work ); int LAPACKE_cpteqr( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz ); int LAPACKE_cpteqr_work( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz, float* work ); int LAPACKE_cptrfs( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_cptrfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, const float* df, const MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cptsv( int matrix_layout, int n, int nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cptsv_work( int matrix_layout, int n, int nrhs, float* d, MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cptsvx( int matrix_layout, char fact, int n, int nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cptsvx_work( int matrix_layout, char fact, int n, int nrhs, const float* d, const MKL_Complex8* e, float* df, MKL_Complex8* ef, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cpttrf( int n, float* d, MKL_Complex8* e ); int LAPACKE_cpttrf_work( int n, float* d, MKL_Complex8* e ); int LAPACKE_cpttrs( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cpttrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* d, const MKL_Complex8* e, MKL_Complex8* b, int ldb ); int LAPACKE_cspcon( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond ); int LAPACKE_cspcon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_csprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_csprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* afp, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_cspsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cspsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* ap, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_cspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* afp, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_csptrf( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_csptrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, int* ipiv ); int LAPACKE_csptri( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv ); int LAPACKE_csptri_work( int matrix_layout, char uplo, int n, MKL_Complex8* ap, const int* ipiv, MKL_Complex8* work ); int LAPACKE_csptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* ap, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_cstedc( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz ); int LAPACKE_cstedc_work( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cstegr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz ); int LAPACKE_cstegr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_cstein( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, int ldz, int* ifailv ); int LAPACKE_cstein_work( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, MKL_Complex8* z, int ldz, float* work, int* iwork, int* ifailv ); int LAPACKE_cstemr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, MKL_Complex8* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_cstemr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, MKL_Complex8* z, int ldz, int nzc, int* isuppz, int* tryrac, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_csteqr( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz ); int LAPACKE_csteqr_work( int matrix_layout, char compz, int n, float* d, float* e, MKL_Complex8* z, int ldz, float* work ); int LAPACKE_csycon( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond ); int LAPACKE_csycon_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_csyconv( int matrix_layout, char uplo, char way, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* e ); int LAPACKE_csyconv_work( int matrix_layout, char uplo, char way, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* e ); int LAPACKE_csyequb( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_csyequb_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, float* s, float* scond, float* amax, MKL_Complex8* work ); int LAPACKE_csyr( int matrix_layout, char uplo, int n, MKL_Complex8 alpha, const MKL_Complex8* x, int incx, MKL_Complex8* a, int lda ); int LAPACKE_csyr_work( int matrix_layout, char uplo, int n, MKL_Complex8 alpha, const MKL_Complex8* x, int incx, MKL_Complex8* a, int lda ); int LAPACKE_csyrfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_csyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_csyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_csyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* af, int ldaf, const int* ipiv, const float* s, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_csysv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_rook( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csysv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_csysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, const MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* ferr, float* berr, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_csysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_csysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* af, int ldaf, int* ipiv, char* equed, float* s, MKL_Complex8* b, int ldb, MKL_Complex8* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, MKL_Complex8* work, float* rwork ); int LAPACKE_csyswapr( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_csyswapr_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int i1, int i2 ); int LAPACKE_csytrf( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_csytrf_rook( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_csytrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytrf_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytri( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_csytri2( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv ); int LAPACKE_csytri2_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytri2x( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, int nb ); int LAPACKE_csytri2x_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work, int nb ); int LAPACKE_csytri_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* work ); int LAPACKE_csytrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work ); int LAPACKE_csytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_ctbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex8* ab, int ldab, float* rcond ); int LAPACKE_ctbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex8* ab, int ldab, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_ctbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_ctbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_ctbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_ctbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex8* ab, int ldab, MKL_Complex8* b, int ldb ); int LAPACKE_ctfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex8 alpha, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_ctfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex8 alpha, const MKL_Complex8* a, MKL_Complex8* b, int ldb ); int LAPACKE_ctftri( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex8* a ); int LAPACKE_ctftri_work( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex8* a ); int LAPACKE_ctfttp( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* ap ); int LAPACKE_ctfttp_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* ap ); int LAPACKE_ctfttr( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* a, int lda ); int LAPACKE_ctfttr_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* arf, MKL_Complex8* a, int lda ); int LAPACKE_ctgevc( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex8* s, int lds, const MKL_Complex8* p, int ldp, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m ); int LAPACKE_ctgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex8* s, int lds, const MKL_Complex8* p, int ldp, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, MKL_Complex8* work, float* rwork ); int LAPACKE_ctgexc( int matrix_layout, int wantq, int wantz, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int ifst, int ilst ); int LAPACKE_ctgexc_work( int matrix_layout, int wantq, int wantz, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int ifst, int ilst ); int LAPACKE_ctgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int* m, float* pl, float* pr, float* dif ); int LAPACKE_ctgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* alpha, MKL_Complex8* beta, MKL_Complex8* q, int ldq, MKL_Complex8* z, int ldz, int* m, float* pl, float* pr, float* dif, MKL_Complex8* work, int lwork, int* iwork, int liwork ); int LAPACKE_ctgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, int* ncycle ); int LAPACKE_ctgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float tola, float tolb, float* alpha, float* beta, MKL_Complex8* u, int ldu, MKL_Complex8* v, int ldv, MKL_Complex8* q, int ldq, MKL_Complex8* work, int* ncycle ); int LAPACKE_ctgsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* dif, int mm, int* m ); int LAPACKE_ctgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* dif, int mm, int* m, MKL_Complex8* work, int lwork, int* iwork ); int LAPACKE_ctgsyl( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, const MKL_Complex8* d, int ldd, const MKL_Complex8* e, int lde, MKL_Complex8* f, int ldf, float* scale, float* dif ); int LAPACKE_ctgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, const MKL_Complex8* d, int ldd, const MKL_Complex8* e, int lde, MKL_Complex8* f, int ldf, float* scale, float* dif, MKL_Complex8* work, int lwork, int* iwork ); int LAPACKE_ctpcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* ap, float* rcond ); int LAPACKE_ctpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* ap, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_ctpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work ); int LAPACKE_ctpqrt( int matrix_layout, int m, int n, int l, int nb, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt ); int LAPACKE_ctpqrt2( int matrix_layout, int m, int n, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt ); int LAPACKE_ctpqrt2_work( int matrix_layout, int m, int n, int l, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt ); int LAPACKE_ctpqrt_work( int matrix_layout, int m, int n, int l, int nb, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* t, int ldt, MKL_Complex8* work ); int LAPACKE_ctprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex8* v, int ldv, const MKL_Complex8* t, int ldt, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work, int ldwork ); int LAPACKE_ctprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_ctprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_ctptri( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* ap ); int LAPACKE_ctptri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* ap ); int LAPACKE_ctptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_ctptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* ap, MKL_Complex8* b, int ldb ); int LAPACKE_ctpttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* arf ); int LAPACKE_ctpttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* arf ); int LAPACKE_ctpttr( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* a, int lda ); int LAPACKE_ctpttr_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, MKL_Complex8* a, int lda ); int LAPACKE_ctrcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* a, int lda, float* rcond ); int LAPACKE_ctrcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex8* a, int lda, float* rcond, MKL_Complex8* work, float* rwork ); int LAPACKE_ctrevc( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m ); int LAPACKE_ctrevc_work( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* vl, int ldvl, MKL_Complex8* vr, int ldvr, int mm, int* m, MKL_Complex8* work, float* rwork ); int LAPACKE_ctrexc( int matrix_layout, char compq, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, int ifst, int ilst ); int LAPACKE_ctrexc_work( int matrix_layout, char compq, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, int ifst, int ilst ); int LAPACKE_ctrrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr ); int LAPACKE_ctrrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, const MKL_Complex8* x, int ldx, float* ferr, float* berr, MKL_Complex8* work, float* rwork ); int LAPACKE_ctrsen( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, MKL_Complex8* w, int* m, float* s, float* sep ); int LAPACKE_ctrsen_work( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex8* t, int ldt, MKL_Complex8* q, int ldq, MKL_Complex8* w, int* m, float* s, float* sep, MKL_Complex8* work, int lwork ); int LAPACKE_ctrsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* t, int ldt, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* sep, int mm, int* m ); int LAPACKE_ctrsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex8* t, int ldt, const MKL_Complex8* vl, int ldvl, const MKL_Complex8* vr, int ldvr, float* s, float* sep, int mm, int* m, MKL_Complex8* work, int ldwork, float* rwork ); int LAPACKE_ctrsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, float* scale ); int LAPACKE_ctrsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* b, int ldb, MKL_Complex8* c, int ldc, float* scale ); int LAPACKE_ctrtri( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* a, int lda ); int LAPACKE_ctrtri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex8* a, int lda ); int LAPACKE_ctrtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctrtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_ctrttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* arf ); int LAPACKE_ctrttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* arf ); int LAPACKE_ctrttp( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* ap ); int LAPACKE_ctrttp_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, MKL_Complex8* ap ); int LAPACKE_ctzrzf( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau ); int LAPACKE_ctzrzf_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunbdb( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2 ); int LAPACKE_cunbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, float* phi, MKL_Complex8* taup1, MKL_Complex8* taup2, MKL_Complex8* tauq1, MKL_Complex8* tauq2, MKL_Complex8* work, int lwork ); int LAPACKE_cuncsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t ); int LAPACKE_cuncsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x21, int ldx21, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t ); int LAPACKE_cuncsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x21, int ldx21, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork ); int LAPACKE_cuncsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex8* x11, int ldx11, MKL_Complex8* x12, int ldx12, MKL_Complex8* x21, int ldx21, MKL_Complex8* x22, int ldx22, float* theta, MKL_Complex8* u1, int ldu1, MKL_Complex8* u2, int ldu2, MKL_Complex8* v1t, int ldv1t, MKL_Complex8* v2t, int ldv2t, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork ); int LAPACKE_cungbr( int matrix_layout, char vect, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungbr_work( int matrix_layout, char vect, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunghr( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cunghr_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunglq( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cunglq_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungql( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungql_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungqr( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungqr_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungrq( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungrq_work( int matrix_layout, int m, int n, int k, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cungtr( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* tau ); int LAPACKE_cungtr_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* work, int lwork ); int LAPACKE_cunmbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmql( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmql_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmrq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cunmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cunmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cupgtr( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, int ldq ); int LAPACKE_cupgtr_work( int matrix_layout, char uplo, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* q, int ldq, MKL_Complex8* work ); int LAPACKE_cupmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, int ldc ); int LAPACKE_cupmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex8* ap, const MKL_Complex8* tau, MKL_Complex8* c, int ldc, MKL_Complex8* work ); int LAPACKE_dbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e ); int LAPACKE_dbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* work, int lwork ); int LAPACKE_dbdsdc( int matrix_layout, char uplo, char compq, int n, double* d, double* e, double* u, int ldu, double* vt, int ldvt, double* q, int* iq ); int LAPACKE_dbdsdc_work( int matrix_layout, char uplo, char compq, int n, double* d, double* e, double* u, int ldu, double* vt, int ldvt, double* q, int* iq, double* work, int* iwork ); int LAPACKE_dbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, double* vt, int ldvt, double* u, int ldu, double* c, int ldc ); int LAPACKE_dbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, double* vt, int ldvt, double* u, int ldu, double* c, int ldc, double* work ); int LAPACKE_dbdsvdx( int matrix_layout, char uplo, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* ns, double* s, double* z, int ldz, int* superb ); int LAPACKE_dbdsvdx_work( int matrix_layout, char uplo, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* ns, double* s, double* z, int ldz, double* work, int* iwork ); int LAPACKE_ddisna( char job, int m, int n, const double* d, double* sep ); int LAPACKE_ddisna_work( char job, int m, int n, const double* d, double* sep ); int LAPACKE_dgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, double* ab, int ldab, double* d, double* e, double* q, int ldq, double* pt, int ldpt, double* c, int ldc ); int LAPACKE_dgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, double* ab, int ldab, double* d, double* e, double* q, int ldq, double* pt, int ldpt, double* c, int ldc, double* work ); int LAPACKE_dgbcon( int matrix_layout, char norm, int n, int kl, int ku, const double* ab, int ldab, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const double* ab, int ldab, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dgbequ( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbequb( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const double* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, double* ab, int ldab, int* ipiv, double* b, int ldb ); int LAPACKE_dgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, double* ab, int ldab, int* ipiv, double* b, int ldb ); int LAPACKE_dgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_dgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, double* ab, int ldab, double* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgbtrf( int matrix_layout, int m, int n, int kl, int ku, double* ab, int ldab, int* ipiv ); int LAPACKE_dgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, double* ab, int ldab, int* ipiv ); int LAPACKE_dgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const int* ipiv, double* b, int ldb ); int LAPACKE_dgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const double* ab, int ldab, const int* ipiv, double* b, int ldb ); int LAPACKE_dgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, double* v, int ldv ); int LAPACKE_dgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, double* v, int ldv ); int LAPACKE_dgebal( int matrix_layout, char job, int n, double* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_dgebal_work( int matrix_layout, char job, int n, double* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_dgebrd( int matrix_layout, int m, int n, double* a, int lda, double* d, double* e, double* tauq, double* taup ); int LAPACKE_dgebrd_work( int matrix_layout, int m, int n, double* a, int lda, double* d, double* e, double* tauq, double* taup, double* work, int lwork ); int LAPACKE_dgecon( int matrix_layout, char norm, int n, const double* a, int lda, double anorm, double* rcond ); int LAPACKE_dgecon_work( int matrix_layout, char norm, int n, const double* a, int lda, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dgeequ( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgeequ_work( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgeequb( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgeequb_work( int matrix_layout, int m, int n, const double* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_dgees( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs ); int LAPACKE_dgees_work( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs, double* work, int lwork, int* bwork ); int LAPACKE_dgeesx( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, char sense, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs, double* rconde, double* rcondv ); int LAPACKE_dgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_D_SELECT2 select, char sense, int n, double* a, int lda, int* sdim, double* wr, double* wi, double* vs, int ldvs, double* rconde, double* rcondv, double* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_dgeev( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr ); int LAPACKE_dgeev_work( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr, double* work, int lwork ); int LAPACKE_dgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv ); int LAPACKE_dgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* wr, double* wi, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, double* work, int lwork, int* iwork ); int LAPACKE_dgehrd( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, double* tau ); int LAPACKE_dgehrd_work( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, double* a, int lda, double* sva, double* u, int ldu, double* v, int ldv, double* stat, int* istat ); int LAPACKE_dgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, double* a, int lda, double* sva, double* u, int ldu, double* v, int ldv, double* work, int lwork, int* iwork ); int LAPACKE_dgelq2( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgelq2_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work ); int LAPACKE_dgelqf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgelqf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgels( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dgels_work( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* work, int lwork ); int LAPACKE_dgelsd( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_dgelsd_work( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank, double* work, int lwork, int* iwork ); int LAPACKE_dgelss( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_dgelss_work( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* s, double rcond, int* rank, double* work, int lwork ); int LAPACKE_dgelsy( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, int* jpvt, double rcond, int* rank ); int LAPACKE_dgelsy_work( int matrix_layout, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, int* jpvt, double rcond, int* rank, double* work, int lwork ); int LAPACKE_dgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const double* v, int ldv, const double* t, int ldt, double* c, int ldc ); int LAPACKE_dgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const double* v, int ldv, const double* t, int ldt, double* c, int ldc, double* work ); int LAPACKE_dgeqlf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqlf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgeqp3( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau ); int LAPACKE_dgeqp3_work( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau, double* work, int lwork ); int LAPACKE_dgeqpf( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau ); int LAPACKE_dgeqpf_work( int matrix_layout, int m, int n, double* a, int lda, int* jpvt, double* tau, double* work ); int LAPACKE_dgeqr2( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqr2_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work ); int LAPACKE_dgeqrf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqrf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgeqrfp( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgeqrfp_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgeqrt( int matrix_layout, int m, int n, int nb, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt2( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt2_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt3( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt3_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int ldt ); int LAPACKE_dgeqrt_work( int matrix_layout, int m, int n, int nb, double* a, int lda, double* t, int ldt, double* work ); int LAPACKE_dgerfs( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dgerfs_work( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* r, const double* c, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgerqf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dgerqf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_dgesdd( int matrix_layout, char jobz, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt ); int LAPACKE_dgesdd_work( int matrix_layout, char jobz, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt, double* work, int lwork, int* iwork ); int LAPACKE_dgesv( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dgesv_work( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt, double* superb ); int LAPACKE_dgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, double* a, int lda, double* s, double* u, int ldu, double* vt, int ldvt, double* work, int lwork ); int LAPACKE_dgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, double* a, int lda, double vl, double vu, int il, int iu, int *ns, double* s, double* u, int ldu, double* vt, int ldvt, int* superb ); int LAPACKE_dgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, double* a, int lda, double vl, double vu, int il, int iu, int *ns, double* s, double* u, int ldu, double* vt, int ldvt, double* work, int lwork, int* iwork ); int LAPACKE_dgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, double* a, int lda, double* sva, int mv, double* v, int ldv, double* stat ); int LAPACKE_dgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, double* a, int lda, double* sva, int mv, double* v, int ldv, double* work, int lwork ); int LAPACKE_dgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_dgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* r, double* c, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dgetf2( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetf2_work( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf2( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf2_work( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetrf_work( int matrix_layout, int m, int n, double* a, int lda, int* ipiv ); int LAPACKE_dgetri( int matrix_layout, int n, double* a, int lda, const int* ipiv ); int LAPACKE_dgetri_work( int matrix_layout, int n, double* a, int lda, const int* ipiv, double* work, int lwork ); int LAPACKE_dgetrs( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dgetrs_work( int matrix_layout, char trans, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, double* v, int ldv ); int LAPACKE_dggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, double* v, int ldv ); int LAPACKE_dggbal( int matrix_layout, char job, int n, double* a, int lda, double* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale ); int LAPACKE_dggbal_work( int matrix_layout, char job, int n, double* a, int lda, double* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work ); int LAPACKE_dgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr ); int LAPACKE_dgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr ); int LAPACKE_dgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* work, int lwork, int* bwork ); int LAPACKE_dgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* work, int lwork, int* bwork ); int LAPACKE_dggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, char sense, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* rconde, double* rcondv ); int LAPACKE_dggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_D_SELECT3 selctg, char sense, int n, double* a, int lda, double* b, int ldb, int* sdim, double* alphar, double* alphai, double* beta, double* vsl, int ldvsl, double* vsr, int ldvsr, double* rconde, double* rcondv, double* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_dggev( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr ); int LAPACKE_dggev3( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr ); int LAPACKE_dggev3_work( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, double* work, int lwork ); int LAPACKE_dggev_work( int matrix_layout, char jobvl, char jobvr, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, double* work, int lwork ); int LAPACKE_dggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv ); int LAPACKE_dggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* vl, int ldvl, double* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, double* work, int lwork, int* iwork, int* bwork ); int LAPACKE_dggglm( int matrix_layout, int n, int m, int p, double* a, int lda, double* b, int ldb, double* d, double* x, double* y ); int LAPACKE_dggglm_work( int matrix_layout, int n, int m, int p, double* a, int lda, double* b, int ldb, double* d, double* x, double* y, double* work, int lwork ); int LAPACKE_dgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz ); int LAPACKE_dgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz, double* work, int lwork ); int LAPACKE_dgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz ); int LAPACKE_dgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz ); int LAPACKE_dgglse( int matrix_layout, int m, int n, int p, double* a, int lda, double* b, int ldb, double* c, double* d, double* x ); int LAPACKE_dgglse_work( int matrix_layout, int m, int n, int p, double* a, int lda, double* b, int ldb, double* c, double* d, double* x, double* work, int lwork ); int LAPACKE_dggqrf( int matrix_layout, int n, int m, int p, double* a, int lda, double* taua, double* b, int ldb, double* taub ); int LAPACKE_dggqrf_work( int matrix_layout, int n, int m, int p, double* a, int lda, double* taua, double* b, int ldb, double* taub, double* work, int lwork ); int LAPACKE_dggrqf( int matrix_layout, int m, int p, int n, double* a, int lda, double* taua, double* b, int ldb, double* taub ); int LAPACKE_dggrqf_work( int matrix_layout, int m, int p, int n, double* a, int lda, double* taua, double* b, int ldb, double* taub, double* work, int lwork ); int LAPACKE_dggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork ); int LAPACKE_dggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork ); int LAPACKE_dggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, double* work, int lwork, int* iwork ); int LAPACKE_dggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, double* a, int lda, double* b, int ldb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, double* work, int* iwork ); int LAPACKE_dggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq ); int LAPACKE_dggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq ); int LAPACKE_dggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork, double* tau, double* work, int lwork ); int LAPACKE_dggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, double* a, int lda, double* b, int ldb, double tola, double tolb, int* k, int* l, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* iwork, double* tau, double* work ); int LAPACKE_dgtcon( char norm, int n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dgtcon_work( char norm, int n, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dgtrfs( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* dlf, const double* df, const double* duf, const double* du2, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgtsv( int matrix_layout, int n, int nrhs, double* dl, double* d, double* du, double* b, int ldb ); int LAPACKE_dgtsv_work( int matrix_layout, int n, int nrhs, double* dl, double* d, double* du, double* b, int ldb ); int LAPACKE_dgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, double* dlf, double* df, double* duf, double* du2, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dgttrf( int n, double* dl, double* d, double* du, double* du2, int* ipiv ); int LAPACKE_dgttrf_work( int n, double* dl, double* d, double* du, double* du2, int* ipiv ); int LAPACKE_dgttrs( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, int ldb ); int LAPACKE_dgttrs_work( int matrix_layout, char trans, int n, int nrhs, const double* dl, const double* d, const double* du, const double* du2, const int* ipiv, double* b, int ldb ); int LAPACKE_dhgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, double* h, int ldh, double* t, int ldt, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz ); int LAPACKE_dhgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, double* h, int ldh, double* t, int ldt, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz, double* work, int lwork ); int LAPACKE_dhsein( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const double* h, int ldh, double* wr, const double* wi, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_dhsein_work( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const double* h, int ldh, double* wr, const double* wi, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, double* work, int* ifaill, int* ifailr ); int LAPACKE_dhseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, double* h, int ldh, double* wr, double* wi, double* z, int ldz ); int LAPACKE_dhseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, double* h, int ldh, double* wr, double* wi, double* z, int ldz, double* work, int lwork ); int LAPACKE_dlacn2( int n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); int LAPACKE_dlacn2_work( int n, double* v, double* x, int* isgn, double* est, int* kase, int* isave ); int LAPACKE_dlacpy( int matrix_layout, char uplo, int m, int n, const double* a, int lda, double* b, int ldb ); int LAPACKE_dlacpy_work( int matrix_layout, char uplo, int m, int n, const double* a, int lda, double* b, int ldb ); int LAPACKE_dlag2s( int matrix_layout, int m, int n, const double* a, int lda, float* sa, int ldsa ); int LAPACKE_dlag2s_work( int matrix_layout, int m, int n, const double* a, int lda, float* sa, int ldsa ); int LAPACKE_dlagge( int matrix_layout, int m, int n, int kl, int ku, const double* d, double* a, int lda, int* iseed ); int LAPACKE_dlagge_work( int matrix_layout, int m, int n, int kl, int ku, const double* d, double* a, int lda, int* iseed, double* work ); int LAPACKE_dlagsy( int matrix_layout, int n, int k, const double* d, double* a, int lda, int* iseed ); int LAPACKE_dlagsy_work( int matrix_layout, int n, int k, const double* d, double* a, int lda, int* iseed, double* work ); int LAPACKE_dlapmr( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlapmr_work( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlapmt( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlapmt_work( int matrix_layout, int forwrd, int m, int n, double* x, int ldx, int* k ); int LAPACKE_dlarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const double* v, int ldv, const double* t, int ldt, double* c, int ldc ); int LAPACKE_dlarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const double* v, int ldv, const double* t, int ldt, double* c, int ldc, double* work, int ldwork ); int LAPACKE_dlarfg( int n, double* alpha, double* x, int incx, double* tau ); int LAPACKE_dlarfg_work( int n, double* alpha, double* x, int incx, double* tau ); int LAPACKE_dlarft( int matrix_layout, char direct, char storev, int n, int k, const double* v, int ldv, const double* tau, double* t, int ldt ); int LAPACKE_dlarft_work( int matrix_layout, char direct, char storev, int n, int k, const double* v, int ldv, const double* tau, double* t, int ldt ); int LAPACKE_dlarfx( int matrix_layout, char side, int m, int n, const double* v, double tau, double* c, int ldc, double* work ); int LAPACKE_dlarfx_work( int matrix_layout, char side, int m, int n, const double* v, double tau, double* c, int ldc, double* work ); int LAPACKE_dlarnv( int idist, int* iseed, int n, double* x ); int LAPACKE_dlarnv_work( int idist, int* iseed, int n, double* x ); int LAPACKE_dlartgp( double f, double g, double* cs, double* sn, double* r ); int LAPACKE_dlartgp_work( double f, double g, double* cs, double* sn, double* r ); int LAPACKE_dlartgs( double x, double y, double sigma, double* cs, double* sn ); int LAPACKE_dlartgs_work( double x, double y, double sigma, double* cs, double* sn ); int LAPACKE_dlascl( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, double* a, int lda ); int LAPACKE_dlascl_work( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, double* a, int lda ); int LAPACKE_dlaset( int matrix_layout, char uplo, int m, int n, double alpha, double beta, double* a, int lda ); int LAPACKE_dlaset_work( int matrix_layout, char uplo, int m, int n, double alpha, double beta, double* a, int lda ); int LAPACKE_dlasrt( char id, int n, double* d ); int LAPACKE_dlasrt_work( char id, int n, double* d ); int LAPACKE_dlaswp( int matrix_layout, int n, double* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_dlaswp_work( int matrix_layout, int n, double* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_dlatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, double* a, int lda ); int LAPACKE_dlatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, double* a, int lda, double* work ); int LAPACKE_dlauum( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dlauum_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dopgtr( int matrix_layout, char uplo, int n, const double* ap, const double* tau, double* q, int ldq ); int LAPACKE_dopgtr_work( int matrix_layout, char uplo, int n, const double* ap, const double* tau, double* q, int ldq, double* work ); int LAPACKE_dopmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* ap, const double* tau, double* c, int ldc ); int LAPACKE_dopmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* ap, const double* tau, double* c, int ldc, double* work ); int LAPACKE_dorbdb( int matrix_layout, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2 ); int LAPACKE_dorbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* phi, double* taup1, double* taup2, double* tauq1, double* tauq2, double* work, int lwork ); int LAPACKE_dorcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t ); int LAPACKE_dorcsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, double* x11, int ldx11, double* x21, int ldx21, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t ); int LAPACKE_dorcsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, double* x11, int ldx11, double* x21, int ldx21, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* work, int lwork, int* iwork ); int LAPACKE_dorcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, double* x11, int ldx11, double* x12, int ldx12, double* x21, int ldx21, double* x22, int ldx22, double* theta, double* u1, int ldu1, double* u2, int ldu2, double* v1t, int ldv1t, double* v2t, int ldv2t, double* work, int lwork, int* iwork ); int LAPACKE_dorgbr( int matrix_layout, char vect, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgbr_work( int matrix_layout, char vect, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorghr( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, const double* tau ); int LAPACKE_dorghr_work( int matrix_layout, int n, int ilo, int ihi, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorglq( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorglq_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgql( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgql_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgqr( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgqr_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgrq( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau ); int LAPACKE_dorgrq_work( int matrix_layout, int m, int n, int k, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dorgtr( int matrix_layout, char uplo, int n, double* a, int lda, const double* tau ); int LAPACKE_dorgtr_work( int matrix_layout, char uplo, int n, double* a, int lda, const double* tau, double* work, int lwork ); int LAPACKE_dormbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormlq( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormql( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormql_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormqr( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormrq( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dormtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* a, int lda, const double* tau, double* c, int ldc ); int LAPACKE_dormtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const double* a, int lda, const double* tau, double* c, int ldc, double* work, int lwork ); int LAPACKE_dpbcon( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double anorm, double* rcond ); int LAPACKE_dpbcon_work( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dpbequ( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_dpbequ_work( int matrix_layout, char uplo, int n, int kd, const double* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_dpbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dpbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, const double* afb, int ldafb, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dpbstf( int matrix_layout, char uplo, int n, int kb, double* bb, int ldbb ); int LAPACKE_dpbstf_work( int matrix_layout, char uplo, int n, int kb, double* bb, int ldbb ); int LAPACKE_dpbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* afb, int ldafb, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dpbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, double* ab, int ldab, double* afb, int ldafb, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dpbtrf( int matrix_layout, char uplo, int n, int kd, double* ab, int ldab ); int LAPACKE_dpbtrf_work( int matrix_layout, char uplo, int n, int kd, double* ab, int ldab ); int LAPACKE_dpbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dpftrf( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftrf_work( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftri( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftri_work( int matrix_layout, char transr, char uplo, int n, double* a ); int LAPACKE_dpftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const double* a, double* b, int ldb ); int LAPACKE_dpftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const double* a, double* b, int ldb ); int LAPACKE_dpocon( int matrix_layout, char uplo, int n, const double* a, int lda, double anorm, double* rcond ); int LAPACKE_dpocon_work( int matrix_layout, char uplo, int n, const double* a, int lda, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dpoequ( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dpoequ_work( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dpoequb( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dpoequb_work( int matrix_layout, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dporfs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dporfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dposv( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dposv_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dpotrf( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrf2( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrf2_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrf_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotri( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotri_work( int matrix_layout, char uplo, int n, double* a, int lda ); int LAPACKE_dpotrs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dpotrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dppcon( int matrix_layout, char uplo, int n, const double* ap, double anorm, double* rcond ); int LAPACKE_dppcon_work( int matrix_layout, char uplo, int n, const double* ap, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dppequ( int matrix_layout, char uplo, int n, const double* ap, double* s, double* scond, double* amax ); int LAPACKE_dppequ_work( int matrix_layout, char uplo, int n, const double* ap, double* s, double* scond, double* amax ); int LAPACKE_dpprfs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dpprfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dppsv( int matrix_layout, char uplo, int n, int nrhs, double* ap, double* b, int ldb ); int LAPACKE_dppsv_work( int matrix_layout, char uplo, int n, int nrhs, double* ap, double* b, int ldb ); int LAPACKE_dppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* ap, double* afp, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* ap, double* afp, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dpptrf( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptrf_work( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptri( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptri_work( int matrix_layout, char uplo, int n, double* ap ); int LAPACKE_dpptrs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dpptrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dpstrf( int matrix_layout, char uplo, int n, double* a, int lda, int* piv, int* rank, double tol ); int LAPACKE_dpstrf_work( int matrix_layout, char uplo, int n, double* a, int lda, int* piv, int* rank, double tol, double* work ); int LAPACKE_dptcon( int n, const double* d, const double* e, double anorm, double* rcond ); int LAPACKE_dptcon_work( int n, const double* d, const double* e, double anorm, double* rcond, double* work ); int LAPACKE_dpteqr( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dpteqr_work( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz, double* work ); int LAPACKE_dptrfs( int matrix_layout, int n, int nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dptrfs_work( int matrix_layout, int n, int nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work ); int LAPACKE_dptsv( int matrix_layout, int n, int nrhs, double* d, double* e, double* b, int ldb ); int LAPACKE_dptsv_work( int matrix_layout, int n, int nrhs, double* d, double* e, double* b, int ldb ); int LAPACKE_dptsvx( int matrix_layout, char fact, int n, int nrhs, const double* d, const double* e, double* df, double* ef, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dptsvx_work( int matrix_layout, char fact, int n, int nrhs, const double* d, const double* e, double* df, double* ef, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work ); int LAPACKE_dpttrf( int n, double* d, double* e ); int LAPACKE_dpttrf_work( int n, double* d, double* e ); int LAPACKE_dpttrs( int matrix_layout, int n, int nrhs, const double* d, const double* e, double* b, int ldb ); int LAPACKE_dpttrs_work( int matrix_layout, int n, int nrhs, const double* d, const double* e, double* b, int ldb ); int LAPACKE_dsbev( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work ); int LAPACKE_dsbevd( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, double* ab, int ldab, const double* bb, int ldbb, double* x, int ldx ); int LAPACKE_dsbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, double* ab, int ldab, const double* bb, int ldbb, double* x, int ldx, double* work ); int LAPACKE_dsbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz ); int LAPACKE_dsbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz, double* work ); int LAPACKE_dsbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz ); int LAPACKE_dsbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, double* ab, int ldab, double* bb, int ldbb, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsbtrd( int matrix_layout, char vect, char uplo, int n, int kd, double* ab, int ldab, double* d, double* e, double* q, int ldq ); int LAPACKE_dsbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, double* ab, int ldab, double* d, double* e, double* q, int ldq, double* work ); int LAPACKE_dsfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const double* a, int lda, double beta, double* c ); int LAPACKE_dsfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const double* a, int lda, double beta, double* c ); int LAPACKE_dsgesv( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* x, int ldx, int* iter ); int LAPACKE_dsgesv_work( int matrix_layout, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* x, int ldx, double* work, float* swork, int* iter ); int LAPACKE_dspcon( int matrix_layout, char uplo, int n, const double* ap, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dspcon_work( int matrix_layout, char uplo, int n, const double* ap, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dspev( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz ); int LAPACKE_dspev_work( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz, double* work ); int LAPACKE_dspevd( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz ); int LAPACKE_dspevd_work( int matrix_layout, char jobz, char uplo, int n, double* ap, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dspevx( int matrix_layout, char jobz, char range, char uplo, int n, double* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dspevx_work( int matrix_layout, char jobz, char range, char uplo, int n, double* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dspgst( int matrix_layout, int itype, char uplo, int n, double* ap, const double* bp ); int LAPACKE_dspgst_work( int matrix_layout, int itype, char uplo, int n, double* ap, const double* bp ); int LAPACKE_dspgv( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz ); int LAPACKE_dspgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz, double* work ); int LAPACKE_dspgvd( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz ); int LAPACKE_dspgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* ap, double* bp, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dspgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* ap, double* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dspgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* ap, double* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsposv( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb, double* x, int ldx, int* iter ); int LAPACKE_dsposv_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* b, int ldb, double* x, int ldx, double* work, float* swork, int* iter ); int LAPACKE_dsprfs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dsprfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const double* afp, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dspsv( int matrix_layout, char uplo, int n, int nrhs, double* ap, int* ipiv, double* b, int ldb ); int LAPACKE_dspsv_work( int matrix_layout, char uplo, int n, int nrhs, double* ap, int* ipiv, double* b, int ldb ); int LAPACKE_dspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* ap, double* afp, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* ap, double* afp, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dsptrd( int matrix_layout, char uplo, int n, double* ap, double* d, double* e, double* tau ); int LAPACKE_dsptrd_work( int matrix_layout, char uplo, int n, double* ap, double* d, double* e, double* tau ); int LAPACKE_dsptrf( int matrix_layout, char uplo, int n, double* ap, int* ipiv ); int LAPACKE_dsptrf_work( int matrix_layout, char uplo, int n, double* ap, int* ipiv ); int LAPACKE_dsptri( int matrix_layout, char uplo, int n, double* ap, const int* ipiv ); int LAPACKE_dsptri_work( int matrix_layout, char uplo, int n, double* ap, const int* ipiv, double* work ); int LAPACKE_dsptrs( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const int* ipiv, double* b, int ldb ); int LAPACKE_dsptrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* ap, const int* ipiv, double* b, int ldb ); int LAPACKE_dstebz( char range, char order, int n, double vl, double vu, int il, int iu, double abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit ); int LAPACKE_dstebz_work( char range, char order, int n, double vl, double vu, int il, int iu, double abstol, const double* d, const double* e, int* m, int* nsplit, double* w, int* iblock, int* isplit, double* work, int* iwork ); int LAPACKE_dstedc( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dstedc_work( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstegr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dstegr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstein( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, double* z, int ldz, int* ifailv ); int LAPACKE_dstein_work( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, double* z, int ldz, double* work, int* iwork, int* ifailv ); int LAPACKE_dstemr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, double* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_dstemr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, double* z, int ldz, int nzc, int* isuppz, int* tryrac, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsteqr( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dsteqr_work( int matrix_layout, char compz, int n, double* d, double* e, double* z, int ldz, double* work ); int LAPACKE_dsterf( int n, double* d, double* e ); int LAPACKE_dsterf_work( int n, double* d, double* e ); int LAPACKE_dstev( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dstev_work( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz, double* work ); int LAPACKE_dstevd( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz ); int LAPACKE_dstevd_work( int matrix_layout, char jobz, int n, double* d, double* e, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstevr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dstevr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dstevx( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dstevx_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int* iwork, int* ifail ); int LAPACKE_dsycon( int matrix_layout, char uplo, int n, const double* a, int lda, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dsycon_work( int matrix_layout, char uplo, int n, const double* a, int lda, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dsyconv( int matrix_layout, char uplo, char way, int n, double* a, int lda, const int* ipiv, double* e ); int LAPACKE_dsyconv_work( int matrix_layout, char uplo, char way, int n, double* a, int lda, const int* ipiv, double* e ); int LAPACKE_dsyequb( int matrix_layout, char uplo, int n, const double* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_dsyequb_work( int matrix_layout, char uplo, int n, const double* a, int lda, double* s, double* scond, double* amax, double* work ); int LAPACKE_dsyev( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyev_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork ); int LAPACKE_dsyevd( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyevd_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevr( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dsyevr_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevx( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsyevx_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsygst( int matrix_layout, int itype, char uplo, int n, double* a, int lda, const double* b, int ldb ); int LAPACKE_dsygst_work( int matrix_layout, int itype, char uplo, int n, double* a, int lda, const double* b, int ldb ); int LAPACKE_dsygv( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w ); int LAPACKE_dsygv_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w, double* work, int lwork ); int LAPACKE_dsygvd( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w ); int LAPACKE_dsygvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsygvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* a, int lda, double* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsygvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, double* a, int lda, double* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsyrfs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dsyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* b, int ldb, double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dsyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dsyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const double* a, int lda, const double* af, int ldaf, const int* ipiv, const double* s, const double* b, int ldb, double* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dsysv( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_rook( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsysv_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* a, int lda, double* af, int ldaf, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_dsysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const double* a, int lda, double* af, int ldaf, int* ipiv, const double* b, int ldb, double* x, int ldx, double* rcond, double* ferr, double* berr, double* work, int lwork, int* iwork ); int LAPACKE_dsysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_dsysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, double* a, int lda, double* af, int ldaf, int* ipiv, char* equed, double* s, double* b, int ldb, double* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, double* work, int* iwork ); int LAPACKE_dsyswapr( int matrix_layout, char uplo, int n, double* a, int lda, int i1, int i2 ); int LAPACKE_dsyswapr_work( int matrix_layout, char uplo, int n, double* a, int lda, int i1, int i2 ); int LAPACKE_dsytrd( int matrix_layout, char uplo, int n, double* a, int lda, double* d, double* e, double* tau ); int LAPACKE_dsytrd_work( int matrix_layout, char uplo, int n, double* a, int lda, double* d, double* e, double* tau, double* work, int lwork ); int LAPACKE_dsytrf( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv ); int LAPACKE_dsytrf_rook( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv ); int LAPACKE_dsytrf_rook_work( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv, double* work, int lwork ); int LAPACKE_dsytrf_work( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv, double* work, int lwork ); int LAPACKE_dsytri( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv ); int LAPACKE_dsytri2( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv ); int LAPACKE_dsytri2_work( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, double* work, int lwork ); int LAPACKE_dsytri2x( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, int nb ); int LAPACKE_dsytri2x_work( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, double* work, int nb ); int LAPACKE_dsytri_work( int matrix_layout, char uplo, int n, double* a, int lda, const int* ipiv, double* work ); int LAPACKE_dsytrs( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs2( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb, double* work ); int LAPACKE_dsytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dtbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const double* ab, int ldab, double* rcond ); int LAPACKE_dtbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const double* ab, int ldab, double* rcond, double* work, int* iwork ); int LAPACKE_dtbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dtbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dtbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dtbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const double* ab, int ldab, double* b, int ldb ); int LAPACKE_dtfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, double alpha, const double* a, double* b, int ldb ); int LAPACKE_dtfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, double alpha, const double* a, double* b, int ldb ); int LAPACKE_dtftri( int matrix_layout, char transr, char uplo, char diag, int n, double* a ); int LAPACKE_dtftri_work( int matrix_layout, char transr, char uplo, char diag, int n, double* a ); int LAPACKE_dtfttp( int matrix_layout, char transr, char uplo, int n, const double* arf, double* ap ); int LAPACKE_dtfttp_work( int matrix_layout, char transr, char uplo, int n, const double* arf, double* ap ); int LAPACKE_dtfttr( int matrix_layout, char transr, char uplo, int n, const double* arf, double* a, int lda ); int LAPACKE_dtfttr_work( int matrix_layout, char transr, char uplo, int n, const double* arf, double* a, int lda ); int LAPACKE_dtgevc( int matrix_layout, char side, char howmny, const int* select, int n, const double* s, int lds, const double* p, int ldp, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m ); int LAPACKE_dtgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const double* s, int lds, const double* p, int ldp, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, double* work ); int LAPACKE_dtgexc( int matrix_layout, int wantq, int wantz, int n, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz, int* ifst, int* ilst ); int LAPACKE_dtgexc_work( int matrix_layout, int wantq, int wantz, int n, double* a, int lda, double* b, int ldb, double* q, int ldq, double* z, int ldz, int* ifst, int* ilst, double* work, int lwork ); int LAPACKE_dtgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz, int* m, double* pl, double* pr, double* dif ); int LAPACKE_dtgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, double* a, int lda, double* b, int ldb, double* alphar, double* alphai, double* beta, double* q, int ldq, double* z, int ldz, int* m, double* pl, double* pr, double* dif, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dtgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, double* a, int lda, double* b, int ldb, double tola, double tolb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, int* ncycle ); int LAPACKE_dtgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, double* a, int lda, double* b, int ldb, double tola, double tolb, double* alpha, double* beta, double* u, int ldu, double* v, int ldv, double* q, int ldq, double* work, int* ncycle ); int LAPACKE_dtgsna( int matrix_layout, char job, char howmny, const int* select, int n, const double* a, int lda, const double* b, int ldb, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* dif, int mm, int* m ); int LAPACKE_dtgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const double* a, int lda, const double* b, int ldb, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* dif, int mm, int* m, double* work, int lwork, int* iwork ); int LAPACKE_dtgsyl( int matrix_layout, char trans, int ijob, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, const double* d, int ldd, const double* e, int lde, double* f, int ldf, double* scale, double* dif ); int LAPACKE_dtgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, const double* d, int ldd, const double* e, int lde, double* f, int ldf, double* scale, double* dif, double* work, int lwork, int* iwork ); int LAPACKE_dtpcon( int matrix_layout, char norm, char uplo, char diag, int n, const double* ap, double* rcond ); int LAPACKE_dtpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const double* ap, double* rcond, double* work, int* iwork ); int LAPACKE_dtpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb ); int LAPACKE_dtpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb, double* work ); int LAPACKE_dtpqrt( int matrix_layout, int m, int n, int l, int nb, double* a, int lda, double* b, int ldb, double* t, int ldt ); int LAPACKE_dtpqrt2( int matrix_layout, int m, int n, int l, double* a, int lda, double* b, int ldb, double* t, int ldt ); int LAPACKE_dtpqrt2_work( int matrix_layout, int m, int n, int l, double* a, int lda, double* b, int ldb, double* t, int ldt ); int LAPACKE_dtpqrt_work( int matrix_layout, int m, int n, int l, int nb, double* a, int lda, double* b, int ldb, double* t, int ldt, double* work ); int LAPACKE_dtprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb ); int LAPACKE_dtprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const double* v, int ldv, const double* t, int ldt, double* a, int lda, double* b, int ldb, double* work, int ldwork ); int LAPACKE_dtprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dtprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dtptri( int matrix_layout, char uplo, char diag, int n, double* ap ); int LAPACKE_dtptri_work( int matrix_layout, char uplo, char diag, int n, double* ap ); int LAPACKE_dtptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dtptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* ap, double* b, int ldb ); int LAPACKE_dtpttf( int matrix_layout, char transr, char uplo, int n, const double* ap, double* arf ); int LAPACKE_dtpttf_work( int matrix_layout, char transr, char uplo, int n, const double* ap, double* arf ); int LAPACKE_dtpttr( int matrix_layout, char uplo, int n, const double* ap, double* a, int lda ); int LAPACKE_dtpttr_work( int matrix_layout, char uplo, int n, const double* ap, double* a, int lda ); int LAPACKE_dtrcon( int matrix_layout, char norm, char uplo, char diag, int n, const double* a, int lda, double* rcond ); int LAPACKE_dtrcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const double* a, int lda, double* rcond, double* work, int* iwork ); int LAPACKE_dtrevc( int matrix_layout, char side, char howmny, int* select, int n, const double* t, int ldt, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m ); int LAPACKE_dtrevc_work( int matrix_layout, char side, char howmny, int* select, int n, const double* t, int ldt, double* vl, int ldvl, double* vr, int ldvr, int mm, int* m, double* work ); int LAPACKE_dtrexc( int matrix_layout, char compq, int n, double* t, int ldt, double* q, int ldq, int* ifst, int* ilst ); int LAPACKE_dtrexc_work( int matrix_layout, char compq, int n, double* t, int ldt, double* q, int ldq, int* ifst, int* ilst, double* work ); int LAPACKE_dtrrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr ); int LAPACKE_dtrrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, const double* b, int ldb, const double* x, int ldx, double* ferr, double* berr, double* work, int* iwork ); int LAPACKE_dtrsen( int matrix_layout, char job, char compq, const int* select, int n, double* t, int ldt, double* q, int ldq, double* wr, double* wi, int* m, double* s, double* sep ); int LAPACKE_dtrsen_work( int matrix_layout, char job, char compq, const int* select, int n, double* t, int ldt, double* q, int ldq, double* wr, double* wi, int* m, double* s, double* sep, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dtrsna( int matrix_layout, char job, char howmny, const int* select, int n, const double* t, int ldt, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* sep, int mm, int* m ); int LAPACKE_dtrsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const double* t, int ldt, const double* vl, int ldvl, const double* vr, int ldvr, double* s, double* sep, int mm, int* m, double* work, int ldwork, int* iwork ); int LAPACKE_dtrsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, double* scale ); int LAPACKE_dtrsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const double* a, int lda, const double* b, int ldb, double* c, int ldc, double* scale ); int LAPACKE_dtrtri( int matrix_layout, char uplo, char diag, int n, double* a, int lda ); int LAPACKE_dtrtri_work( int matrix_layout, char uplo, char diag, int n, double* a, int lda ); int LAPACKE_dtrtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dtrtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const double* a, int lda, double* b, int ldb ); int LAPACKE_dtrttf( int matrix_layout, char transr, char uplo, int n, const double* a, int lda, double* arf ); int LAPACKE_dtrttf_work( int matrix_layout, char transr, char uplo, int n, const double* a, int lda, double* arf ); int LAPACKE_dtrttp( int matrix_layout, char uplo, int n, const double* a, int lda, double* ap ); int LAPACKE_dtrttp_work( int matrix_layout, char uplo, int n, const double* a, int lda, double* ap ); int LAPACKE_dtzrzf( int matrix_layout, int m, int n, double* a, int lda, double* tau ); int LAPACKE_dtzrzf_work( int matrix_layout, int m, int n, double* a, int lda, double* tau, double* work, int lwork ); int LAPACKE_mkl_cgetrfnpi( int matrix_layout, int m, int n, int nfact, MKL_Complex8* a, int lda ); int LAPACKE_mkl_cgetrfnpi_work( int matrix_layout, int m, int n, int nfact, MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctppack( int matrix_layout, char uplo, char trans, int n, MKL_Complex8* ap, int i, int j, int rows, int cols, const MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctppack_work( int matrix_layout, char uplo, char trans, int n, MKL_Complex8* ap, int i, int j, int rows, int cols, const MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctpunpack( int matrix_layout, char uplo, char trans, int n, const MKL_Complex8* ap, int i, int j, int rows, int cols, MKL_Complex8* a, int lda ); int LAPACKE_mkl_ctpunpack_work( int matrix_layout, char uplo, char trans, int n, const MKL_Complex8* ap, int i, int j, int rows, int cols, MKL_Complex8* a, int lda ); int LAPACKE_mkl_dgetrfnpi( int matrix_layout, int m, int n, int nfact, double* a, int lda ); int LAPACKE_mkl_dgetrfnpi_work( int matrix_layout, int m, int n, int nfact, double* a, int lda ); int LAPACKE_mkl_dtppack( int matrix_layout, char uplo, char trans, int n, double* ap, int i, int j, int rows, int cols, const double* a, int lda ); int LAPACKE_mkl_dtppack_work( int matrix_layout, char uplo, char trans, int n, double* ap, int i, int j, int rows, int cols, const double* a, int lda ); int LAPACKE_mkl_dtpunpack( int matrix_layout, char uplo, char trans, int n, const double* ap, int i, int j, int rows, int cols, double* a, int lda ); int LAPACKE_mkl_dtpunpack_work( int matrix_layout, char uplo, char trans, int n, const double* ap, int i, int j, int rows, int cols, double* a, int lda ); int LAPACKE_mkl_sgetrfnpi( int matrix_layout, int m, int n, int nfact, float* a, int lda); int LAPACKE_mkl_sgetrfnpi_work( int matrix_layout, int m, int n, int nfact, float* a, int lda ); int LAPACKE_mkl_stppack( int matrix_layout, char uplo, char trans, int n, float* ap, int i, int j, int rows, int cols, const float* a, int lda ); int LAPACKE_mkl_stppack_work( int matrix_layout, char uplo, char trans, int n, float* ap, int i, int j, int rows, int cols, const float* a, int lda ); int LAPACKE_mkl_stpunpack( int matrix_layout, char uplo, char trans, int n, const float* ap, int i, int j, int rows, int cols, float* a, int lda ); int LAPACKE_mkl_stpunpack_work( int matrix_layout, char uplo, char trans, int n, const float* ap, int i, int j, int rows, int cols, float* a, int lda ); int LAPACKE_mkl_zgetrfnpi( int matrix_layout, int m, int n, int nfact, MKL_Complex16* a, int lda ); int LAPACKE_mkl_zgetrfnpi_work( int matrix_layout, int m, int n, int nfact, MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztppack( int matrix_layout, char uplo, char trans, int n, MKL_Complex16* ap, int i, int j, int rows, int cols, const MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztppack_work( int matrix_layout, char uplo, char trans, int n, MKL_Complex16* ap, int i, int j, int rows, int cols, const MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztpunpack( int matrix_layout, char uplo, char trans, int n, const MKL_Complex16* ap, int i, int j, int rows, int cols, MKL_Complex16* a, int lda ); int LAPACKE_mkl_ztpunpack_work( int matrix_layout, char uplo, char trans, int n, const MKL_Complex16* ap, int i, int j, int rows, int cols, MKL_Complex16* a, int lda ); int LAPACKE_sbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e ); int LAPACKE_sbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, float* theta, float* phi, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t, float* b11d, float* b11e, float* b12d, float* b12e, float* b21d, float* b21e, float* b22d, float* b22e, float* work, int lwork ); int LAPACKE_sbdsdc( int matrix_layout, char uplo, char compq, int n, float* d, float* e, float* u, int ldu, float* vt, int ldvt, float* q, int* iq ); int LAPACKE_sbdsdc_work( int matrix_layout, char uplo, char compq, int n, float* d, float* e, float* u, int ldu, float* vt, int ldvt, float* q, int* iq, float* work, int* iwork ); int LAPACKE_sbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, float* vt, int ldvt, float* u, int ldu, float* c, int ldc ); int LAPACKE_sbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, float* d, float* e, float* vt, int ldvt, float* u, int ldu, float* c, int ldc, float* work ); int LAPACKE_sbdsvdx( int matrix_layout, char uplo, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* ns, float* s, float* z, int ldz, int* superb ); int LAPACKE_sbdsvdx_work( int matrix_layout, char uplo, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* ns, float* s, float* z, int ldz, float* work, int* iwork ); int LAPACKE_sdisna( char job, int m, int n, const float* d, float* sep ); int LAPACKE_sdisna_work( char job, int m, int n, const float* d, float* sep ); int LAPACKE_sgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, float* ab, int ldab, float* d, float* e, float* q, int ldq, float* pt, int ldpt, float* c, int ldc ); int LAPACKE_sgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, float* ab, int ldab, float* d, float* e, float* q, int ldq, float* pt, int ldpt, float* c, int ldc, float* work ); int LAPACKE_sgbcon( int matrix_layout, char norm, int n, int kl, int ku, const float* ab, int ldab, const int* ipiv, float anorm, float* rcond ); int LAPACKE_sgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const float* ab, int ldab, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sgbequ( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbequb( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const float* ab, int ldab, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, float* ab, int ldab, int* ipiv, float* b, int ldb ); int LAPACKE_sgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, float* ab, int ldab, int* ipiv, float* b, int ldb ); int LAPACKE_sgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_sgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, float* ab, int ldab, float* afb, int ldafb, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgbtrf( int matrix_layout, int m, int n, int kl, int ku, float* ab, int ldab, int* ipiv ); int LAPACKE_sgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, float* ab, int ldab, int* ipiv ); int LAPACKE_sgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const int* ipiv, float* b, int ldb ); int LAPACKE_sgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const float* ab, int ldab, const int* ipiv, float* b, int ldb ); int LAPACKE_sgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, float* v, int ldv ); int LAPACKE_sgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* scale, int m, float* v, int ldv ); int LAPACKE_sgebal( int matrix_layout, char job, int n, float* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_sgebal_work( int matrix_layout, char job, int n, float* a, int lda, int* ilo, int* ihi, float* scale ); int LAPACKE_sgebrd( int matrix_layout, int m, int n, float* a, int lda, float* d, float* e, float* tauq, float* taup ); int LAPACKE_sgebrd_work( int matrix_layout, int m, int n, float* a, int lda, float* d, float* e, float* tauq, float* taup, float* work, int lwork ); int LAPACKE_sgecon( int matrix_layout, char norm, int n, const float* a, int lda, float anorm, float* rcond ); int LAPACKE_sgecon_work( int matrix_layout, char norm, int n, const float* a, int lda, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sgeequ( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgeequ_work( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgeequb( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgeequb_work( int matrix_layout, int m, int n, const float* a, int lda, float* r, float* c, float* rowcnd, float* colcnd, float* amax ); int LAPACKE_sgees( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs ); int LAPACKE_sgees_work( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs, float* work, int lwork, int* bwork ); int LAPACKE_sgeesx( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, char sense, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs, float* rconde, float* rcondv ); int LAPACKE_sgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_S_SELECT2 select, char sense, int n, float* a, int lda, int* sdim, float* wr, float* wi, float* vs, int ldvs, float* rconde, float* rcondv, float* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_sgeev( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr ); int LAPACKE_sgeev_work( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr, float* work, int lwork ); int LAPACKE_sgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv ); int LAPACKE_sgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* wr, float* wi, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* scale, float* abnrm, float* rconde, float* rcondv, float* work, int lwork, int* iwork ); int LAPACKE_sgehrd( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, float* tau ); int LAPACKE_sgehrd_work( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, float* a, int lda, float* sva, float* u, int ldu, float* v, int ldv, float* stat, int* istat ); int LAPACKE_sgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, float* a, int lda, float* sva, float* u, int ldu, float* v, int ldv, float* work, int lwork, int* iwork ); int LAPACKE_sgelq2( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgelq2_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work ); int LAPACKE_sgelqf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgelqf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgels( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sgels_work( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* work, int lwork ); int LAPACKE_sgelsd( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_sgelsd_work( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank, float* work, int lwork, int* iwork ); int LAPACKE_sgelss( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank ); int LAPACKE_sgelss_work( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* s, float rcond, int* rank, float* work, int lwork ); int LAPACKE_sgelsy( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, int* jpvt, float rcond, int* rank ); int LAPACKE_sgelsy_work( int matrix_layout, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, int* jpvt, float rcond, int* rank, float* work, int lwork ); int LAPACKE_sgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const float* v, int ldv, const float* t, int ldt, float* c, int ldc ); int LAPACKE_sgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const float* v, int ldv, const float* t, int ldt, float* c, int ldc, float* work ); int LAPACKE_sgeqlf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqlf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgeqp3( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau ); int LAPACKE_sgeqp3_work( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau, float* work, int lwork ); int LAPACKE_sgeqpf( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau ); int LAPACKE_sgeqpf_work( int matrix_layout, int m, int n, float* a, int lda, int* jpvt, float* tau, float* work ); int LAPACKE_sgeqr2( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqr2_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work ); int LAPACKE_sgeqrf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqrf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgeqrfp( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgeqrfp_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgeqrt( int matrix_layout, int m, int n, int nb, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt2( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt2_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt3( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt3_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int ldt ); int LAPACKE_sgeqrt_work( int matrix_layout, int m, int n, int nb, float* a, int lda, float* t, int ldt, float* work ); int LAPACKE_sgerfs( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sgerfs_work( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* r, const float* c, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgerqf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_sgerqf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_sgesdd( int matrix_layout, char jobz, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt ); int LAPACKE_sgesdd_work( int matrix_layout, char jobz, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt, float* work, int lwork, int* iwork ); int LAPACKE_sgesv( int matrix_layout, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_sgesv_work( int matrix_layout, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_sgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt, float* superb ); int LAPACKE_sgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, float* a, int lda, float* s, float* u, int ldu, float* vt, int ldvt, float* work, int lwork ); int LAPACKE_sgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, float* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, float* u, int ldu, float* vt, int ldvt, int* superb ); int LAPACKE_sgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, float* a, int lda, float vl, float vu, int il, int iu, int* ns, float* s, float* u, int ldu, float* vt, int ldvt, float* work, int lwork, int* iwork ); int LAPACKE_sgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, float* a, int lda, float* sva, int mv, float* v, int ldv, float* stat ); int LAPACKE_sgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, float* a, int lda, float* sva, int mv, float* v, int ldv, float* work, int lwork ); int LAPACKE_sgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* rpivot ); int LAPACKE_sgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* r, float* c, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sgetf2( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetf2_work( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf2( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf2_work( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetrf_work( int matrix_layout, int m, int n, float* a, int lda, int* ipiv ); int LAPACKE_sgetri( int matrix_layout, int n, float* a, int lda, const int* ipiv ); int LAPACKE_sgetri_work( int matrix_layout, int n, float* a, int lda, const int* ipiv, float* work, int lwork ); int LAPACKE_sgetrs( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_sgetrs_work( int matrix_layout, char trans, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_sggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, float* v, int ldv ); int LAPACKE_sggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const float* lscale, const float* rscale, int m, float* v, int ldv ); int LAPACKE_sggbal( int matrix_layout, char job, int n, float* a, int lda, float* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale ); int LAPACKE_sggbal_work( int matrix_layout, char job, int n, float* a, int lda, float* b, int ldb, int* ilo, int* ihi, float* lscale, float* rscale, float* work ); int LAPACKE_sgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr ); int LAPACKE_sgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr ); int LAPACKE_sgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* work, int lwork, int* bwork ); int LAPACKE_sgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* work, int lwork, int* bwork ); int LAPACKE_sggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, char sense, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* rconde, float* rcondv ); int LAPACKE_sggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_S_SELECT3 selctg, char sense, int n, float* a, int lda, float* b, int ldb, int* sdim, float* alphar, float* alphai, float* beta, float* vsl, int ldvsl, float* vsr, int ldvsr, float* rconde, float* rcondv, float* work, int lwork, int* iwork, int liwork, int* bwork ); int LAPACKE_sggev( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr ); int LAPACKE_sggev3( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr ); int LAPACKE_sggev3_work( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, float* work, int lwork ); int LAPACKE_sggev_work( int matrix_layout, char jobvl, char jobvr, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, float* work, int lwork ); int LAPACKE_sggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv ); int LAPACKE_sggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* vl, int ldvl, float* vr, int ldvr, int* ilo, int* ihi, float* lscale, float* rscale, float* abnrm, float* bbnrm, float* rconde, float* rcondv, float* work, int lwork, int* iwork, int* bwork ); int LAPACKE_sggglm( int matrix_layout, int n, int m, int p, float* a, int lda, float* b, int ldb, float* d, float* x, float* y ); int LAPACKE_sggglm_work( int matrix_layout, int n, int m, int p, float* a, int lda, float* b, int ldb, float* d, float* x, float* y, float* work, int lwork ); int LAPACKE_sgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz ); int LAPACKE_sgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz, float* work, int lwork ); int LAPACKE_sgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz ); int LAPACKE_sgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz ); int LAPACKE_sgglse( int matrix_layout, int m, int n, int p, float* a, int lda, float* b, int ldb, float* c, float* d, float* x ); int LAPACKE_sgglse_work( int matrix_layout, int m, int n, int p, float* a, int lda, float* b, int ldb, float* c, float* d, float* x, float* work, int lwork ); int LAPACKE_sggqrf( int matrix_layout, int n, int m, int p, float* a, int lda, float* taua, float* b, int ldb, float* taub ); int LAPACKE_sggqrf_work( int matrix_layout, int n, int m, int p, float* a, int lda, float* taua, float* b, int ldb, float* taub, float* work, int lwork ); int LAPACKE_sggrqf( int matrix_layout, int m, int p, int n, float* a, int lda, float* taua, float* b, int ldb, float* taub ); int LAPACKE_sggrqf_work( int matrix_layout, int m, int p, int n, float* a, int lda, float* taua, float* b, int ldb, float* taub, float* work, int lwork ); int LAPACKE_sggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork ); int LAPACKE_sggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork ); int LAPACKE_sggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, float* work, int lwork, int* iwork ); int LAPACKE_sggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, float* a, int lda, float* b, int ldb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, float* work, int* iwork ); int LAPACKE_sggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq ); int LAPACKE_sggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq ); int LAPACKE_sggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork, float* tau, float* work, int lwork ); int LAPACKE_sggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, float* a, int lda, float* b, int ldb, float tola, float tolb, int* k, int* l, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* iwork, float* tau, float* work ); int LAPACKE_sgtcon( char norm, int n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float anorm, float* rcond ); int LAPACKE_sgtcon_work( char norm, int n, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sgtrfs( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* dlf, const float* df, const float* duf, const float* du2, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgtsv( int matrix_layout, int n, int nrhs, float* dl, float* d, float* du, float* b, int ldb ); int LAPACKE_sgtsv_work( int matrix_layout, int n, int nrhs, float* dl, float* d, float* du, float* b, int ldb ); int LAPACKE_sgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, float* dlf, float* df, float* duf, float* du2, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sgttrf( int n, float* dl, float* d, float* du, float* du2, int* ipiv ); int LAPACKE_sgttrf_work( int n, float* dl, float* d, float* du, float* du2, int* ipiv ); int LAPACKE_sgttrs( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, int ldb ); int LAPACKE_sgttrs_work( int matrix_layout, char trans, int n, int nrhs, const float* dl, const float* d, const float* du, const float* du2, const int* ipiv, float* b, int ldb ); int LAPACKE_shgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, float* h, int ldh, float* t, int ldt, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz ); int LAPACKE_shgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, float* h, int ldh, float* t, int ldt, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz, float* work, int lwork ); int LAPACKE_shsein( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const float* h, int ldh, float* wr, const float* wi, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_shsein_work( int matrix_layout, char job, char eigsrc, char initv, int* select, int n, const float* h, int ldh, float* wr, const float* wi, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, float* work, int* ifaill, int* ifailr ); int LAPACKE_shseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, float* h, int ldh, float* wr, float* wi, float* z, int ldz ); int LAPACKE_shseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, float* h, int ldh, float* wr, float* wi, float* z, int ldz, float* work, int lwork ); int LAPACKE_slacn2( int n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); int LAPACKE_slacn2_work( int n, float* v, float* x, int* isgn, float* est, int* kase, int* isave ); int LAPACKE_slacpy( int matrix_layout, char uplo, int m, int n, const float* a, int lda, float* b, int ldb ); int LAPACKE_slacpy_work( int matrix_layout, char uplo, int m, int n, const float* a, int lda, float* b, int ldb ); int LAPACKE_slag2d( int matrix_layout, int m, int n, const float* sa, int ldsa, double* a, int lda ); int LAPACKE_slag2d_work( int matrix_layout, int m, int n, const float* sa, int ldsa, double* a, int lda ); int LAPACKE_slagge( int matrix_layout, int m, int n, int kl, int ku, const float* d, float* a, int lda, int* iseed ); int LAPACKE_slagge_work( int matrix_layout, int m, int n, int kl, int ku, const float* d, float* a, int lda, int* iseed, float* work ); int LAPACKE_slagsy( int matrix_layout, int n, int k, const float* d, float* a, int lda, int* iseed ); int LAPACKE_slagsy_work( int matrix_layout, int n, int k, const float* d, float* a, int lda, int* iseed, float* work ); int LAPACKE_slapmr( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slapmr_work( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slapmt( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slapmt_work( int matrix_layout, int forwrd, int m, int n, float* x, int ldx, int* k ); int LAPACKE_slarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const float* v, int ldv, const float* t, int ldt, float* c, int ldc ); int LAPACKE_slarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const float* v, int ldv, const float* t, int ldt, float* c, int ldc, float* work, int ldwork ); int LAPACKE_slarfg( int n, float* alpha, float* x, int incx, float* tau ); int LAPACKE_slarfg_work( int n, float* alpha, float* x, int incx, float* tau ); int LAPACKE_slarft( int matrix_layout, char direct, char storev, int n, int k, const float* v, int ldv, const float* tau, float* t, int ldt ); int LAPACKE_slarft_work( int matrix_layout, char direct, char storev, int n, int k, const float* v, int ldv, const float* tau, float* t, int ldt ); int LAPACKE_slarfx( int matrix_layout, char side, int m, int n, const float* v, float tau, float* c, int ldc, float* work ); int LAPACKE_slarfx_work( int matrix_layout, char side, int m, int n, const float* v, float tau, float* c, int ldc, float* work ); int LAPACKE_slarnv( int idist, int* iseed, int n, float* x ); int LAPACKE_slarnv_work( int idist, int* iseed, int n, float* x ); int LAPACKE_slartgp( float f, float g, float* cs, float* sn, float* r ); int LAPACKE_slartgp_work( float f, float g, float* cs, float* sn, float* r ); int LAPACKE_slartgs( float x, float y, float sigma, float* cs, float* sn ); int LAPACKE_slartgs_work( float x, float y, float sigma, float* cs, float* sn ); int LAPACKE_slascl( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, float* a, int lda ); int LAPACKE_slascl_work( int matrix_layout, char type, int kl, int ku, float cfrom, float cto, int m, int n, float* a, int lda ); int LAPACKE_slaset( int matrix_layout, char uplo, int m, int n, float alpha, float beta, float* a, int lda ); int LAPACKE_slaset_work( int matrix_layout, char uplo, int m, int n, float alpha, float beta, float* a, int lda ); int LAPACKE_slasrt( char id, int n, float* d ); int LAPACKE_slasrt_work( char id, int n, float* d ); int LAPACKE_slaswp( int matrix_layout, int n, float* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_slaswp_work( int matrix_layout, int n, float* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_slatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, float* a, int lda ); int LAPACKE_slatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, float* d, int mode, float cond, float dmax, int kl, int ku, char pack, float* a, int lda, float* work ); int LAPACKE_slauum( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_slauum_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_sopgtr( int matrix_layout, char uplo, int n, const float* ap, const float* tau, float* q, int ldq ); int LAPACKE_sopgtr_work( int matrix_layout, char uplo, int n, const float* ap, const float* tau, float* q, int ldq, float* work ); int LAPACKE_sopmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* ap, const float* tau, float* c, int ldc ); int LAPACKE_sopmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* ap, const float* tau, float* c, int ldc, float* work ); int LAPACKE_sorbdb( int matrix_layout, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2 ); int LAPACKE_sorbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* phi, float* taup1, float* taup2, float* tauq1, float* tauq2, float* work, int lwork ); int LAPACKE_sorcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t ); int LAPACKE_sorcsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, float* x11, int ldx11, float* x21, int ldx21, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t ); int LAPACKE_sorcsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, float* x11, int ldx11, float* x21, int ldx21, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* work, int lwork, int* iwork ); int LAPACKE_sorcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, float* x11, int ldx11, float* x12, int ldx12, float* x21, int ldx21, float* x22, int ldx22, float* theta, float* u1, int ldu1, float* u2, int ldu2, float* v1t, int ldv1t, float* v2t, int ldv2t, float* work, int lwork, int* iwork ); int LAPACKE_sorgbr( int matrix_layout, char vect, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgbr_work( int matrix_layout, char vect, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorghr( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, const float* tau ); int LAPACKE_sorghr_work( int matrix_layout, int n, int ilo, int ihi, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorglq( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorglq_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgql( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgql_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgqr( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgqr_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgrq( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau ); int LAPACKE_sorgrq_work( int matrix_layout, int m, int n, int k, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sorgtr( int matrix_layout, char uplo, int n, float* a, int lda, const float* tau ); int LAPACKE_sorgtr_work( int matrix_layout, char uplo, int n, float* a, int lda, const float* tau, float* work, int lwork ); int LAPACKE_sormbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormlq( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormql( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormql_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormqr( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormrq( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_sormtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* a, int lda, const float* tau, float* c, int ldc ); int LAPACKE_sormtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const float* a, int lda, const float* tau, float* c, int ldc, float* work, int lwork ); int LAPACKE_spbcon( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float anorm, float* rcond ); int LAPACKE_spbcon_work( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_spbequ( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_spbequ_work( int matrix_layout, char uplo, int n, int kd, const float* ab, int ldab, float* s, float* scond, float* amax ); int LAPACKE_spbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_spbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, const float* afb, int ldafb, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_spbstf( int matrix_layout, char uplo, int n, int kb, float* bb, int ldbb ); int LAPACKE_spbstf_work( int matrix_layout, char uplo, int n, int kb, float* bb, int ldbb ); int LAPACKE_spbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* b, int ldb ); int LAPACKE_spbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* b, int ldb ); int LAPACKE_spbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* afb, int ldafb, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_spbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, float* ab, int ldab, float* afb, int ldafb, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_spbtrf( int matrix_layout, char uplo, int n, int kd, float* ab, int ldab ); int LAPACKE_spbtrf_work( int matrix_layout, char uplo, int n, int kd, float* ab, int ldab ); int LAPACKE_spbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_spbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_spftrf( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftrf_work( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftri( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftri_work( int matrix_layout, char transr, char uplo, int n, float* a ); int LAPACKE_spftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const float* a, float* b, int ldb ); int LAPACKE_spftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const float* a, float* b, int ldb ); int LAPACKE_spocon( int matrix_layout, char uplo, int n, const float* a, int lda, float anorm, float* rcond ); int LAPACKE_spocon_work( int matrix_layout, char uplo, int n, const float* a, int lda, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_spoequ( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_spoequ_work( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_spoequb( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_spoequb_work( int matrix_layout, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_sporfs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sporfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_sposv( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sposv_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_sposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_spotrf( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrf2( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrf2_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrf_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotri( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotri_work( int matrix_layout, char uplo, int n, float* a, int lda ); int LAPACKE_spotrs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_spotrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_sppcon( int matrix_layout, char uplo, int n, const float* ap, float anorm, float* rcond ); int LAPACKE_sppcon_work( int matrix_layout, char uplo, int n, const float* ap, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sppequ( int matrix_layout, char uplo, int n, const float* ap, float* s, float* scond, float* amax ); int LAPACKE_sppequ_work( int matrix_layout, char uplo, int n, const float* ap, float* s, float* scond, float* amax ); int LAPACKE_spprfs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_spprfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sppsv( int matrix_layout, char uplo, int n, int nrhs, float* ap, float* b, int ldb ); int LAPACKE_sppsv_work( int matrix_layout, char uplo, int n, int nrhs, float* ap, float* b, int ldb ); int LAPACKE_sppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* ap, float* afp, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* ap, float* afp, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_spptrf( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptrf_work( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptri( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptri_work( int matrix_layout, char uplo, int n, float* ap ); int LAPACKE_spptrs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_spptrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_spstrf( int matrix_layout, char uplo, int n, float* a, int lda, int* piv, int* rank, float tol ); int LAPACKE_spstrf_work( int matrix_layout, char uplo, int n, float* a, int lda, int* piv, int* rank, float tol, float* work ); int LAPACKE_sptcon( int n, const float* d, const float* e, float anorm, float* rcond ); int LAPACKE_sptcon_work( int n, const float* d, const float* e, float anorm, float* rcond, float* work ); int LAPACKE_spteqr( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_spteqr_work( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz, float* work ); int LAPACKE_sptrfs( int matrix_layout, int n, int nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_sptrfs_work( int matrix_layout, int n, int nrhs, const float* d, const float* e, const float* df, const float* ef, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work ); int LAPACKE_sptsv( int matrix_layout, int n, int nrhs, float* d, float* e, float* b, int ldb ); int LAPACKE_sptsv_work( int matrix_layout, int n, int nrhs, float* d, float* e, float* b, int ldb ); int LAPACKE_sptsvx( int matrix_layout, char fact, int n, int nrhs, const float* d, const float* e, float* df, float* ef, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sptsvx_work( int matrix_layout, char fact, int n, int nrhs, const float* d, const float* e, float* df, float* ef, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work ); int LAPACKE_spttrf( int n, float* d, float* e ); int LAPACKE_spttrf_work( int n, float* d, float* e ); int LAPACKE_spttrs( int matrix_layout, int n, int nrhs, const float* d, const float* e, float* b, int ldb ); int LAPACKE_spttrs_work( int matrix_layout, int n, int nrhs, const float* d, const float* e, float* b, int ldb ); int LAPACKE_ssbev( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work ); int LAPACKE_ssbevd( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, float* ab, int ldab, const float* bb, int ldbb, float* x, int ldx ); int LAPACKE_ssbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, float* ab, int ldab, const float* bb, int ldbb, float* x, int ldx, float* work ); int LAPACKE_ssbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz ); int LAPACKE_ssbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz, float* work ); int LAPACKE_ssbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz ); int LAPACKE_ssbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, float* ab, int ldab, float* bb, int ldbb, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssbtrd( int matrix_layout, char vect, char uplo, int n, int kd, float* ab, int ldab, float* d, float* e, float* q, int ldq ); int LAPACKE_ssbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, float* ab, int ldab, float* d, float* e, float* q, int ldq, float* work ); int LAPACKE_ssfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const float* a, int lda, float beta, float* c ); int LAPACKE_ssfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, float alpha, const float* a, int lda, float beta, float* c ); int LAPACKE_sspcon( int matrix_layout, char uplo, int n, const float* ap, const int* ipiv, float anorm, float* rcond ); int LAPACKE_sspcon_work( int matrix_layout, char uplo, int n, const float* ap, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_sspev( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz ); int LAPACKE_sspev_work( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz, float* work ); int LAPACKE_sspevd( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz ); int LAPACKE_sspevd_work( int matrix_layout, char jobz, char uplo, int n, float* ap, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sspevx( int matrix_layout, char jobz, char range, char uplo, int n, float* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_sspevx_work( int matrix_layout, char jobz, char range, char uplo, int n, float* ap, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_sspgst( int matrix_layout, int itype, char uplo, int n, float* ap, const float* bp ); int LAPACKE_sspgst_work( int matrix_layout, int itype, char uplo, int n, float* ap, const float* bp ); int LAPACKE_sspgv( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz ); int LAPACKE_sspgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz, float* work ); int LAPACKE_sspgvd( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz ); int LAPACKE_sspgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* ap, float* bp, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sspgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* ap, float* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_sspgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* ap, float* bp, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssprfs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_ssprfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const float* afp, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_sspsv( int matrix_layout, char uplo, int n, int nrhs, float* ap, int* ipiv, float* b, int ldb ); int LAPACKE_sspsv_work( int matrix_layout, char uplo, int n, int nrhs, float* ap, int* ipiv, float* b, int ldb ); int LAPACKE_sspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* ap, float* afp, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_sspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* ap, float* afp, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_ssptrd( int matrix_layout, char uplo, int n, float* ap, float* d, float* e, float* tau ); int LAPACKE_ssptrd_work( int matrix_layout, char uplo, int n, float* ap, float* d, float* e, float* tau ); int LAPACKE_ssptrf( int matrix_layout, char uplo, int n, float* ap, int* ipiv ); int LAPACKE_ssptrf_work( int matrix_layout, char uplo, int n, float* ap, int* ipiv ); int LAPACKE_ssptri( int matrix_layout, char uplo, int n, float* ap, const int* ipiv ); int LAPACKE_ssptri_work( int matrix_layout, char uplo, int n, float* ap, const int* ipiv, float* work ); int LAPACKE_ssptrs( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const int* ipiv, float* b, int ldb ); int LAPACKE_ssptrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* ap, const int* ipiv, float* b, int ldb ); int LAPACKE_sstebz( char range, char order, int n, float vl, float vu, int il, int iu, float abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit ); int LAPACKE_sstebz_work( char range, char order, int n, float vl, float vu, int il, int iu, float abstol, const float* d, const float* e, int* m, int* nsplit, float* w, int* iblock, int* isplit, float* work, int* iwork ); int LAPACKE_sstedc( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_sstedc_work( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstegr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_sstegr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstein( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, float* z, int ldz, int* ifailv ); int LAPACKE_sstein_work( int matrix_layout, int n, const float* d, const float* e, int m, const float* w, const int* iblock, const int* isplit, float* z, int ldz, float* work, int* iwork, int* ifailv ); int LAPACKE_sstemr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, float* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_sstemr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, int* m, float* w, float* z, int ldz, int nzc, int* isuppz, int* tryrac, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssteqr( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_ssteqr_work( int matrix_layout, char compz, int n, float* d, float* e, float* z, int ldz, float* work ); int LAPACKE_ssterf( int n, float* d, float* e ); int LAPACKE_ssterf_work( int n, float* d, float* e ); int LAPACKE_sstev( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_sstev_work( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz, float* work ); int LAPACKE_sstevd( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz ); int LAPACKE_sstevd_work( int matrix_layout, char jobz, int n, float* d, float* e, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstevr( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_sstevr_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_sstevx( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_sstevx_work( int matrix_layout, char jobz, char range, int n, float* d, float* e, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int* iwork, int* ifail ); int LAPACKE_ssycon( int matrix_layout, char uplo, int n, const float* a, int lda, const int* ipiv, float anorm, float* rcond ); int LAPACKE_ssycon_work( int matrix_layout, char uplo, int n, const float* a, int lda, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_ssyconv( int matrix_layout, char uplo, char way, int n, float* a, int lda, const int* ipiv, float* e ); int LAPACKE_ssyconv_work( int matrix_layout, char uplo, char way, int n, float* a, int lda, const int* ipiv, float* e ); int LAPACKE_ssyequb( int matrix_layout, char uplo, int n, const float* a, int lda, float* s, float* scond, float* amax ); int LAPACKE_ssyequb_work( int matrix_layout, char uplo, int n, const float* a, int lda, float* s, float* scond, float* amax, float* work ); int LAPACKE_ssyev( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyev_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork ); int LAPACKE_ssyevd( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyevd_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevr( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_ssyevr_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevx( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssyevx_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssygst( int matrix_layout, int itype, char uplo, int n, float* a, int lda, const float* b, int ldb ); int LAPACKE_ssygst_work( int matrix_layout, int itype, char uplo, int n, float* a, int lda, const float* b, int ldb ); int LAPACKE_ssygv( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w ); int LAPACKE_ssygv_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w, float* work, int lwork ); int LAPACKE_ssygvd( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w ); int LAPACKE_ssygvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssygvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* a, int lda, float* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssygvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, float* a, int lda, float* b, int ldb, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssyrfs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr ); int LAPACKE_ssyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* b, int ldb, float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_ssyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_ssyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const float* a, int lda, const float* af, int ldaf, const int* ipiv, const float* s, const float* b, int ldb, float* x, int ldx, float* rcond, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_ssysv( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_rook( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssysv_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* a, int lda, float* af, int ldaf, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr ); int LAPACKE_ssysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const float* a, int lda, float* af, int ldaf, int* ipiv, const float* b, int ldb, float* x, int ldx, float* rcond, float* ferr, float* berr, float* work, int lwork, int* iwork ); int LAPACKE_ssysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params ); int LAPACKE_ssysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, float* a, int lda, float* af, int ldaf, int* ipiv, char* equed, float* s, float* b, int ldb, float* x, int ldx, float* rcond, float* rpvgrw, float* berr, int n_err_bnds, float* err_bnds_norm, float* err_bnds_comp, int nparams, float* params, float* work, int* iwork ); int LAPACKE_ssyswapr( int matrix_layout, char uplo, int n, float* a, int lda, int i1, int i2 ); int LAPACKE_ssyswapr_work( int matrix_layout, char uplo, int n, float* a, int lda, int i1, int i2 ); int LAPACKE_ssytrd( int matrix_layout, char uplo, int n, float* a, int lda, float* d, float* e, float* tau ); int LAPACKE_ssytrd_work( int matrix_layout, char uplo, int n, float* a, int lda, float* d, float* e, float* tau, float* work, int lwork ); int LAPACKE_ssytrf( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv ); int LAPACKE_ssytrf_rook( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv ); int LAPACKE_ssytrf_rook_work( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv, float* work, int lwork ); int LAPACKE_ssytrf_work( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv, float* work, int lwork ); int LAPACKE_ssytri( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv ); int LAPACKE_ssytri2( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv ); int LAPACKE_ssytri2_work( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, float* work, int lwork ); int LAPACKE_ssytri2x( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, int nb ); int LAPACKE_ssytri2x_work( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, float* work, int nb ); int LAPACKE_ssytri_work( int matrix_layout, char uplo, int n, float* a, int lda, const int* ipiv, float* work ); int LAPACKE_ssytrs( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs2( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb, float* work ); int LAPACKE_ssytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_stbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const float* ab, int ldab, float* rcond ); int LAPACKE_stbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const float* ab, int ldab, float* rcond, float* work, int* iwork ); int LAPACKE_stbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr ); int LAPACKE_stbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_stbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_stbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const float* ab, int ldab, float* b, int ldb ); int LAPACKE_stfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, float alpha, const float* a, float* b, int ldb ); int LAPACKE_stfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, float alpha, const float* a, float* b, int ldb ); int LAPACKE_stftri( int matrix_layout, char transr, char uplo, char diag, int n, float* a ); int LAPACKE_stftri_work( int matrix_layout, char transr, char uplo, char diag, int n, float* a ); int LAPACKE_stfttp( int matrix_layout, char transr, char uplo, int n, const float* arf, float* ap ); int LAPACKE_stfttp_work( int matrix_layout, char transr, char uplo, int n, const float* arf, float* ap ); int LAPACKE_stfttr( int matrix_layout, char transr, char uplo, int n, const float* arf, float* a, int lda ); int LAPACKE_stfttr_work( int matrix_layout, char transr, char uplo, int n, const float* arf, float* a, int lda ); int LAPACKE_stgevc( int matrix_layout, char side, char howmny, const int* select, int n, const float* s, int lds, const float* p, int ldp, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m ); int LAPACKE_stgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const float* s, int lds, const float* p, int ldp, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, float* work ); int LAPACKE_stgexc( int matrix_layout, int wantq, int wantz, int n, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz, int* ifst, int* ilst ); int LAPACKE_stgexc_work( int matrix_layout, int wantq, int wantz, int n, float* a, int lda, float* b, int ldb, float* q, int ldq, float* z, int ldz, int* ifst, int* ilst, float* work, int lwork ); int LAPACKE_stgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz, int* m, float* pl, float* pr, float* dif ); int LAPACKE_stgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, float* a, int lda, float* b, int ldb, float* alphar, float* alphai, float* beta, float* q, int ldq, float* z, int ldz, int* m, float* pl, float* pr, float* dif, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_stgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, float* a, int lda, float* b, int ldb, float tola, float tolb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, int* ncycle ); int LAPACKE_stgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, float* a, int lda, float* b, int ldb, float tola, float tolb, float* alpha, float* beta, float* u, int ldu, float* v, int ldv, float* q, int ldq, float* work, int* ncycle ); int LAPACKE_stgsna( int matrix_layout, char job, char howmny, const int* select, int n, const float* a, int lda, const float* b, int ldb, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* dif, int mm, int* m ); int LAPACKE_stgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const float* a, int lda, const float* b, int ldb, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* dif, int mm, int* m, float* work, int lwork, int* iwork ); int LAPACKE_stgsyl( int matrix_layout, char trans, int ijob, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, const float* d, int ldd, const float* e, int lde, float* f, int ldf, float* scale, float* dif ); int LAPACKE_stgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, const float* d, int ldd, const float* e, int lde, float* f, int ldf, float* scale, float* dif, float* work, int lwork, int* iwork ); int LAPACKE_stpcon( int matrix_layout, char norm, char uplo, char diag, int n, const float* ap, float* rcond ); int LAPACKE_stpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const float* ap, float* rcond, float* work, int* iwork ); int LAPACKE_stpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb ); int LAPACKE_stpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb, float* work ); int LAPACKE_stpqrt( int matrix_layout, int m, int n, int l, int nb, float* a, int lda, float* b, int ldb, float* t, int ldt ); int LAPACKE_stpqrt2( int matrix_layout, int m, int n, int l, float* a, int lda, float* b, int ldb, float* t, int ldt ); int LAPACKE_stpqrt2_work( int matrix_layout, int m, int n, int l, float* a, int lda, float* b, int ldb, float* t, int ldt ); int LAPACKE_stpqrt_work( int matrix_layout, int m, int n, int l, int nb, float* a, int lda, float* b, int ldb, float* t, int ldt, float* work ); int LAPACKE_stprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb); int LAPACKE_stprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const float* v, int ldv, const float* t, int ldt, float* a, int lda, float* b, int ldb, float* work, int ldwork ); int LAPACKE_stprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr ); int LAPACKE_stprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_stptri( int matrix_layout, char uplo, char diag, int n, float* ap ); int LAPACKE_stptri_work( int matrix_layout, char uplo, char diag, int n, float* ap ); int LAPACKE_stptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_stptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* ap, float* b, int ldb ); int LAPACKE_stpttf( int matrix_layout, char transr, char uplo, int n, const float* ap, float* arf ); int LAPACKE_stpttf_work( int matrix_layout, char transr, char uplo, int n, const float* ap, float* arf ); int LAPACKE_stpttr( int matrix_layout, char uplo, int n, const float* ap, float* a, int lda ); int LAPACKE_stpttr_work( int matrix_layout, char uplo, int n, const float* ap, float* a, int lda ); int LAPACKE_strcon( int matrix_layout, char norm, char uplo, char diag, int n, const float* a, int lda, float* rcond ); int LAPACKE_strcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const float* a, int lda, float* rcond, float* work, int* iwork ); int LAPACKE_strevc( int matrix_layout, char side, char howmny, int* select, int n, const float* t, int ldt, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m ); int LAPACKE_strevc_work( int matrix_layout, char side, char howmny, int* select, int n, const float* t, int ldt, float* vl, int ldvl, float* vr, int ldvr, int mm, int* m, float* work ); int LAPACKE_strexc( int matrix_layout, char compq, int n, float* t, int ldt, float* q, int ldq, int* ifst, int* ilst ); int LAPACKE_strexc_work( int matrix_layout, char compq, int n, float* t, int ldt, float* q, int ldq, int* ifst, int* ilst, float* work ); int LAPACKE_strrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr ); int LAPACKE_strrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, const float* b, int ldb, const float* x, int ldx, float* ferr, float* berr, float* work, int* iwork ); int LAPACKE_strsen( int matrix_layout, char job, char compq, const int* select, int n, float* t, int ldt, float* q, int ldq, float* wr, float* wi, int* m, float* s, float* sep ); int LAPACKE_strsen_work( int matrix_layout, char job, char compq, const int* select, int n, float* t, int ldt, float* q, int ldq, float* wr, float* wi, int* m, float* s, float* sep, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_strsna( int matrix_layout, char job, char howmny, const int* select, int n, const float* t, int ldt, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* sep, int mm, int* m ); int LAPACKE_strsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const float* t, int ldt, const float* vl, int ldvl, const float* vr, int ldvr, float* s, float* sep, int mm, int* m, float* work, int ldwork, int* iwork ); int LAPACKE_strsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, float* scale ); int LAPACKE_strsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const float* a, int lda, const float* b, int ldb, float* c, int ldc, float* scale ); int LAPACKE_strtri( int matrix_layout, char uplo, char diag, int n, float* a, int lda ); int LAPACKE_strtri_work( int matrix_layout, char uplo, char diag, int n, float* a, int lda ); int LAPACKE_strtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_strtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const float* a, int lda, float* b, int ldb ); int LAPACKE_strttf( int matrix_layout, char transr, char uplo, int n, const float* a, int lda, float* arf ); int LAPACKE_strttf_work( int matrix_layout, char transr, char uplo, int n, const float* a, int lda, float* arf ); int LAPACKE_strttp( int matrix_layout, char uplo, int n, const float* a, int lda, float* ap ); int LAPACKE_strttp_work( int matrix_layout, char uplo, int n, const float* a, int lda, float* ap ); int LAPACKE_stzrzf( int matrix_layout, int m, int n, float* a, int lda, float* tau ); int LAPACKE_stzrzf_work( int matrix_layout, int m, int n, float* a, int lda, float* tau, float* work, int lwork ); int LAPACKE_zbbcsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e ); int LAPACKE_zbbcsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, int m, int p, int q, double* theta, double* phi, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t, double* b11d, double* b11e, double* b12d, double* b12e, double* b21d, double* b21e, double* b22d, double* b22e, double* rwork, int lrwork ); int LAPACKE_zbdsqr( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, MKL_Complex16* vt, int ldvt, MKL_Complex16* u, int ldu, MKL_Complex16* c, int ldc ); int LAPACKE_zbdsqr_work( int matrix_layout, char uplo, int n, int ncvt, int nru, int ncc, double* d, double* e, MKL_Complex16* vt, int ldvt, MKL_Complex16* u, int ldu, MKL_Complex16* c, int ldc, double* work ); int LAPACKE_zcgesv( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, int* iter ); int LAPACKE_zcgesv_work( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter ); int LAPACKE_zcposv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, int* iter ); int LAPACKE_zcposv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, MKL_Complex16* work, MKL_Complex8* swork, double* rwork, int* iter ); int LAPACKE_zgbbrd( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq, MKL_Complex16* pt, int ldpt, MKL_Complex16* c, int ldc ); int LAPACKE_zgbbrd_work( int matrix_layout, char vect, int m, int n, int ncc, int kl, int ku, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq, MKL_Complex16* pt, int ldpt, MKL_Complex16* c, int ldc, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbcon( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zgbcon_work( int matrix_layout, char norm, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbequ( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbequ_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbequb( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbequb_work( int matrix_layout, int m, int n, int kl, int ku, const MKL_Complex16* ab, int ldab, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgbrfs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zgbrfs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbrfsx( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgbrfsx_work( int matrix_layout, char trans, char equed, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbsv( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgbsv_work( int matrix_layout, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgbsvx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_zgbsvx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbsvxx( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgbsvxx_work( int matrix_layout, char fact, char trans, int n, int kl, int ku, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgbtrf( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex16* ab, int ldab, int* ipiv ); int LAPACKE_zgbtrf_work( int matrix_layout, int m, int n, int kl, int ku, MKL_Complex16* ab, int ldab, int* ipiv ); int LAPACKE_zgbtrs( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgbtrs_work( int matrix_layout, char trans, int n, int kl, int ku, int nrhs, const MKL_Complex16* ab, int ldab, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgebak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zgebak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* scale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zgebal( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_zgebal_work( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, int* ilo, int* ihi, double* scale ); int LAPACKE_zgebrd( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup ); int LAPACKE_zgebrd_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tauq, MKL_Complex16* taup, MKL_Complex16* work, int lwork ); int LAPACKE_zgecon( int matrix_layout, char norm, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond ); int LAPACKE_zgecon_work( int matrix_layout, char norm, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zgeequ( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgeequ_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgeequb( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgeequb_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, double* r, double* c, double* rowcnd, double* colcnd, double* amax ); int LAPACKE_zgees( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs ); int LAPACKE_zgees_work( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zgeesx( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, char sense, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs, double* rconde, double* rcondv ); int LAPACKE_zgeesx_work( int matrix_layout, char jobvs, char sort, LAPACK_Z_SELECT1 select, char sense, int n, MKL_Complex16* a, int lda, int* sdim, MKL_Complex16* w, MKL_Complex16* vs, int ldvs, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zgeev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr ); int LAPACKE_zgeev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgeevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv ); int LAPACKE_zgeevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* scale, double* abnrm, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgehrd( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgehrd_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgejsv( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex16* a, int lda, double* sva, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, double* stat, int* istat ); int LAPACKE_zgejsv_work( int matrix_layout, char joba, char jobu, char jobv, char jobr, char jobt, char jobp, int m, int n, MKL_Complex16* a, int lda, double* sva, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* cwork, int lwork, double* rwork, int lrwork, int* iwork ); int LAPACKE_zgelq2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgelq2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work ); int LAPACKE_zgelqf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgelqf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgels( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zgels_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zgelsd( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_zgelsd_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zgelss( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank ); int LAPACKE_zgelss_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* s, double rcond, int* rank, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgelsy( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* jpvt, double rcond, int* rank ); int LAPACKE_zgelsy_work( int matrix_layout, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* jpvt, double rcond, int* rank, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgemqrt( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc ); int LAPACKE_zgemqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc, MKL_Complex16* work ); int LAPACKE_zgeqlf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqlf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqp3( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau ); int LAPACKE_zgeqp3_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgeqpf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau ); int LAPACKE_zgeqpf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* jpvt, MKL_Complex16* tau, MKL_Complex16* work, double* rwork ); int LAPACKE_zgeqr2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqr2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work ); int LAPACKE_zgeqrf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqrf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqrfp( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgeqrfp_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqrt( int matrix_layout, int m, int n, int nb, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt3( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt3_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt ); int LAPACKE_zgeqrt_work( int matrix_layout, int m, int n, int nb, MKL_Complex16* a, int lda, MKL_Complex16* t, int ldt, MKL_Complex16* work ); int LAPACKE_zgerfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zgerfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgerfsx( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgerfsx_work( int matrix_layout, char trans, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* r, const double* c, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgerqf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_zgerqf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zgesdd( int matrix_layout, char jobz, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt ); int LAPACKE_zgesdd_work( int matrix_layout, char jobz, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zgesv( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgesv_work( int matrix_layout, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgesvd( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, double* superb ); int LAPACKE_zgesvd_work( int matrix_layout, char jobu, char jobvt, int m, int n, MKL_Complex16* a, int lda, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zgesvdx( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, int* ns, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, int* superb ); int LAPACKE_zgesvdx_work( int matrix_layout, char jobu, char jobvt, char range, int m, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, int* ns, double* s, MKL_Complex16* u, int ldu, MKL_Complex16* vt, int ldvt, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zgesvj( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex16 * a, int lda, double* sva, int mv, MKL_Complex16* v, int ldv, double* stat ); int LAPACKE_zgesvj_work( int matrix_layout, char joba, char jobu, char jobv, int m, int n, MKL_Complex16* a, int lda, double* sva, int mv, MKL_Complex16* v, int ldv, MKL_Complex16* cwork, int lwork, double* rwork, int lrwork ); int LAPACKE_zgesvx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, double* rpivot ); int LAPACKE_zgesvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgesvxx( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zgesvxx_work( int matrix_layout, char fact, char trans, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* r, double* c, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zgetf2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetf2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf2( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf2_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetrf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zgetri( int matrix_layout, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zgetri_work( int matrix_layout, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zgetrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgetrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zggbak( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zggbak_work( int matrix_layout, char job, char side, int n, int ilo, int ihi, const double* lscale, const double* rscale, int m, MKL_Complex16* v, int ldv ); int LAPACKE_zggbal( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale ); int LAPACKE_zggbal_work( int matrix_layout, char job, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* ilo, int* ihi, double* lscale, double* rscale, double* work ); int LAPACKE_zgges( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr ); int LAPACKE_zgges3( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr ); int LAPACKE_zgges3_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zgges_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, MKL_Complex16* work, int lwork, double* rwork, int* bwork ); int LAPACKE_zggesx( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, double* rconde, double* rcondv ); int LAPACKE_zggesx_work( int matrix_layout, char jobvsl, char jobvsr, char sort, LAPACK_Z_SELECT2 selctg, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, int* sdim, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vsl, int ldvsl, MKL_Complex16* vsr, int ldvsr, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int liwork, int* bwork ); int LAPACKE_zggev( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr ); int LAPACKE_zggev3( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr ); int LAPACKE_zggev3_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zggev_work( int matrix_layout, char jobvl, char jobvr, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zggevx( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv ); int LAPACKE_zggevx_work( int matrix_layout, char balanc, char jobvl, char jobvr, char sense, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int* ilo, int* ihi, double* lscale, double* rscale, double* abnrm, double* bbnrm, double* rconde, double* rcondv, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* bwork ); int LAPACKE_zggglm( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y ); int LAPACKE_zggglm_work( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* y, MKL_Complex16* work, int lwork ); int LAPACKE_zgghd3( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zgghd3_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork ); int LAPACKE_zgghrd( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zgghrd_work( int matrix_layout, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zgglse( int matrix_layout, int m, int n, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x ); int LAPACKE_zgglse_work( int matrix_layout, int m, int n, int p, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* c, MKL_Complex16* d, MKL_Complex16* x, MKL_Complex16* work, int lwork ); int LAPACKE_zggqrf( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub ); int LAPACKE_zggqrf_work( int matrix_layout, int n, int m, int p, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub, MKL_Complex16* work, int lwork ); int LAPACKE_zggrqf( int matrix_layout, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub ); int LAPACKE_zggrqf_work( int matrix_layout, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* taua, MKL_Complex16* b, int ldb, MKL_Complex16* taub, MKL_Complex16* work, int lwork ); int LAPACKE_zggsvd( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork ); int LAPACKE_zggsvd3( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork ); int LAPACKE_zggsvd3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, MKL_Complex16* work, int lwork, double* rwork, int* iwork ); int LAPACKE_zggsvd_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int n, int p, int* k, int* l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, MKL_Complex16* work, double* rwork, int* iwork ); int LAPACKE_zggsvp( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq ); int LAPACKE_zggsvp3( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq ); int LAPACKE_zggsvp3_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zggsvp_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, int* k, int* l, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* iwork, double* rwork, MKL_Complex16* tau, MKL_Complex16* work ); int LAPACKE_zgtcon( char norm, int n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zgtcon_work( char norm, int n, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zgtrfs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zgtrfs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* dlf, const MKL_Complex16* df, const MKL_Complex16* duf, const MKL_Complex16* du2, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgtsv( int matrix_layout, int n, int nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, int ldb ); int LAPACKE_zgtsv_work( int matrix_layout, int n, int nrhs, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* b, int ldb ); int LAPACKE_zgtsvx( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zgtsvx_work( int matrix_layout, char fact, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, MKL_Complex16* dlf, MKL_Complex16* df, MKL_Complex16* duf, MKL_Complex16* du2, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zgttrf( int n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv ); int LAPACKE_zgttrf_work( int n, MKL_Complex16* dl, MKL_Complex16* d, MKL_Complex16* du, MKL_Complex16* du2, int* ipiv ); int LAPACKE_zgttrs( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zgttrs_work( int matrix_layout, char trans, int n, int nrhs, const MKL_Complex16* dl, const MKL_Complex16* d, const MKL_Complex16* du, const MKL_Complex16* du2, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhbev( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbev_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhbevd( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbevd_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhbevx( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhbevx_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhbgst( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, const MKL_Complex16* bb, int ldbb, MKL_Complex16* x, int ldx ); int LAPACKE_zhbgst_work( int matrix_layout, char vect, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, const MKL_Complex16* bb, int ldbb, MKL_Complex16* x, int ldx, MKL_Complex16* work, double* rwork ); int LAPACKE_zhbgv( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbgv_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhbgvd( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbgvd_work( int matrix_layout, char jobz, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhbgvx( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhbgvx_work( int matrix_layout, char jobz, char range, char uplo, int n, int ka, int kb, MKL_Complex16* ab, int ldab, MKL_Complex16* bb, int ldbb, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhbtrd( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq ); int LAPACKE_zhbtrd_work( int matrix_layout, char vect, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* d, double* e, MKL_Complex16* q, int ldq, MKL_Complex16* work ); int LAPACKE_zhecon( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zhecon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zheequb( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zheequb_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax, MKL_Complex16* work ); int LAPACKE_zheev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zheevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevr( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz ); int LAPACKE_zheevr_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zheevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhegst( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb ); int LAPACKE_zhegst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb ); int LAPACKE_zhegv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w ); int LAPACKE_zhegv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhegvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w ); int LAPACKE_zhegvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhegvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhegvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zherfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zherfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zherfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zherfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zhesv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhesv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zhesvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zhesvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhesvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zhesvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zheswapr( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zheswapr_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zhetrd( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tau ); int LAPACKE_zhetrd_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, double* d, double* e, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zhetrf_rook( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zhetrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetri( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zhetri2( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zhetri2_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetri2x( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, int nb ); int LAPACKE_zhetri2x_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int nb ); int LAPACKE_zhetri_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zhetrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work ); int LAPACKE_zhetrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhfrk( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const MKL_Complex16* a, int lda, double beta, MKL_Complex16* c ); int LAPACKE_zhfrk_work( int matrix_layout, char transr, char uplo, char trans, int n, int k, double alpha, const MKL_Complex16* a, int lda, double beta, MKL_Complex16* c ); int LAPACKE_zhgeqz( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* t, int ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz ); int LAPACKE_zhgeqz_work( int matrix_layout, char job, char compq, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* t, int ldt, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhpcon( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zhpcon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zhpev( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpev_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhpevd( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpevd_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* ap, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhpevx( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhpevx_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* ap, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhpgst( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* ap, const MKL_Complex16* bp ); int LAPACKE_zhpgst_work( int matrix_layout, int itype, char uplo, int n, MKL_Complex16* ap, const MKL_Complex16* bp ); int LAPACKE_zhpgv( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpgv_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork ); int LAPACKE_zhpgvd( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhpgvd_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhpgvx( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhpgvx_work( int matrix_layout, int itype, char jobz, char range, char uplo, int n, MKL_Complex16* ap, MKL_Complex16* bp, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zhprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zhpsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhpsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhpsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zhpsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zhptrd( int matrix_layout, char uplo, int n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau ); int LAPACKE_zhptrd_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, double* d, double* e, MKL_Complex16* tau ); int LAPACKE_zhptrf( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zhptrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zhptri( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv ); int LAPACKE_zhptri_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zhptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhsein( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, int* ifaill, int* ifailr ); int LAPACKE_zhsein_work( int matrix_layout, char job, char eigsrc, char initv, const int* select, int n, const MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, MKL_Complex16* work, double* rwork, int* ifaill, int* ifailr ); int LAPACKE_zhseqr( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhseqr_work( int matrix_layout, char job, char compz, int n, int ilo, int ihi, MKL_Complex16* h, int ldh, MKL_Complex16* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork ); int LAPACKE_zlacgv( int n, MKL_Complex16* x, int incx ); int LAPACKE_zlacgv_work( int n, MKL_Complex16* x, int incx ); int LAPACKE_zlacn2( int n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); int LAPACKE_zlacn2_work( int n, MKL_Complex16* v, MKL_Complex16* x, double* est, int* kase, int* isave ); int LAPACKE_zlacp2( int matrix_layout, char uplo, int m, int n, const double* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlacp2_work( int matrix_layout, char uplo, int m, int n, const double* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlacpy( int matrix_layout, char uplo, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlacpy_work( int matrix_layout, char uplo, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zlag2c( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex8* sa, int ldsa ); int LAPACKE_zlag2c_work( int matrix_layout, int m, int n, const MKL_Complex16* a, int lda, MKL_Complex8* sa, int ldsa ); int LAPACKE_zlagge( int matrix_layout, int m, int n, int kl, int ku, const double* d, MKL_Complex16* a, int lda, int* iseed ); int LAPACKE_zlagge_work( int matrix_layout, int m, int n, int kl, int ku, const double* d, MKL_Complex16* a, int lda, int* iseed, MKL_Complex16* work ); int LAPACKE_zlaghe( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed ); int LAPACKE_zlaghe_work( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed, MKL_Complex16* work ); int LAPACKE_zlagsy( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed ); int LAPACKE_zlagsy_work( int matrix_layout, int n, int k, const double* d, MKL_Complex16* a, int lda, int* iseed, MKL_Complex16* work ); int LAPACKE_zlapmr( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlapmr_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlapmt( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlapmt_work( int matrix_layout, int forwrd, int m, int n, MKL_Complex16* x, int ldx, int* k ); int LAPACKE_zlarfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc ); int LAPACKE_zlarfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* c, int ldc, MKL_Complex16* work, int ldwork ); int LAPACKE_zlarfg( int n, MKL_Complex16* alpha, MKL_Complex16* x, int incx, MKL_Complex16* tau ); int LAPACKE_zlarfg_work( int n, MKL_Complex16* alpha, MKL_Complex16* x, int incx, MKL_Complex16* tau ); int LAPACKE_zlarft( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* tau, MKL_Complex16* t, int ldt ); int LAPACKE_zlarft_work( int matrix_layout, char direct, char storev, int n, int k, const MKL_Complex16* v, int ldv, const MKL_Complex16* tau, MKL_Complex16* t, int ldt ); int LAPACKE_zlarfx( int matrix_layout, char side, int m, int n, const MKL_Complex16* v, MKL_Complex16 tau, MKL_Complex16* c, int ldc, MKL_Complex16* work ); int LAPACKE_zlarfx_work( int matrix_layout, char side, int m, int n, const MKL_Complex16* v, MKL_Complex16 tau, MKL_Complex16* c, int ldc, MKL_Complex16* work ); int LAPACKE_zlarnv( int idist, int* iseed, int n, MKL_Complex16* x ); int LAPACKE_zlarnv_work( int idist, int* iseed, int n, MKL_Complex16* x ); int LAPACKE_zlascl( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_zlascl_work( int matrix_layout, char type, int kl, int ku, double cfrom, double cto, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_zlaset( int matrix_layout, char uplo, int m, int n, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16* a, int lda ); int LAPACKE_zlaset_work( int matrix_layout, char uplo, int m, int n, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16* a, int lda ); int LAPACKE_zlaswp( int matrix_layout, int n, MKL_Complex16* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_zlaswp_work( int matrix_layout, int n, MKL_Complex16* a, int lda, int k1, int k2, const int* ipiv, int incx ); int LAPACKE_zlatms( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, MKL_Complex16* a, int lda ); int LAPACKE_zlatms_work( int matrix_layout, int m, int n, char dist, int* iseed, char sym, double* d, int mode, double cond, double dmax, int kl, int ku, char pack, MKL_Complex16* a, int lda, MKL_Complex16* work ); int LAPACKE_zlauum( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zlauum_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpbcon( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double anorm, double* rcond ); int LAPACKE_zpbcon_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zpbequ( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_zpbequ_work( int matrix_layout, char uplo, int n, int kd, const MKL_Complex16* ab, int ldab, double* s, double* scond, double* amax ); int LAPACKE_zpbrfs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zpbrfs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* afb, int ldafb, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpbstf( int matrix_layout, char uplo, int n, int kb, MKL_Complex16* bb, int ldbb ); int LAPACKE_zpbstf_work( int matrix_layout, char uplo, int n, int kb, MKL_Complex16* bb, int ldbb ); int LAPACKE_zpbsv( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpbsv_work( int matrix_layout, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpbsvx( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zpbsvx_work( int matrix_layout, char fact, char uplo, int n, int kd, int nrhs, MKL_Complex16* ab, int ldab, MKL_Complex16* afb, int ldafb, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpbtrf( int matrix_layout, char uplo, int n, int kd, MKL_Complex16* ab, int ldab ); int LAPACKE_zpbtrf_work( int matrix_layout, char uplo, int n, int kd, MKL_Complex16* ab, int ldab ); int LAPACKE_zpbtrs( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpbtrs_work( int matrix_layout, char uplo, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_zpftrf( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftrf_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftri( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftri_work( int matrix_layout, char transr, char uplo, int n, MKL_Complex16* a ); int LAPACKE_zpftrs( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_zpftrs_work( int matrix_layout, char transr, char uplo, int n, int nrhs, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_zpocon( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond ); int LAPACKE_zpocon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zpoequ( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zpoequ_work( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zpoequb( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zpoequb_work( int matrix_layout, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zporfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zporfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zporfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zporfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zposv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zposv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zposvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zposvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zposvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zposvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zpotrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrf2( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrf2_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotri( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotri_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda ); int LAPACKE_zpotrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zpotrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zppcon( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double anorm, double* rcond ); int LAPACKE_zppcon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double anorm, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_zppequ( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double* s, double* scond, double* amax ); int LAPACKE_zppequ_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, double* s, double* scond, double* amax ); int LAPACKE_zpprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zpprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zppsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zppsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zppsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zppsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* ap, MKL_Complex16* afp, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpptrf( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptri( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptri_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap ); int LAPACKE_zpptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zpptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_zpstrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* piv, int* rank, double tol ); int LAPACKE_zpstrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* piv, int* rank, double tol, double* work ); int LAPACKE_zptcon( int n, const double* d, const MKL_Complex16* e, double anorm, double* rcond ); int LAPACKE_zptcon_work( int n, const double* d, const MKL_Complex16* e, double anorm, double* rcond, double* work ); int LAPACKE_zpteqr( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz ); int LAPACKE_zpteqr_work( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz, double* work ); int LAPACKE_zptrfs( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zptrfs_work( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, const double* df, const MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zptsv( int matrix_layout, int n, int nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zptsv_work( int matrix_layout, int n, int nrhs, double* d, MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zptsvx( int matrix_layout, char fact, int n, int nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zptsvx_work( int matrix_layout, char fact, int n, int nrhs, const double* d, const MKL_Complex16* e, double* df, MKL_Complex16* ef, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zpttrf( int n, double* d, MKL_Complex16* e ); int LAPACKE_zpttrf_work( int n, double* d, MKL_Complex16* e ); int LAPACKE_zpttrs( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zpttrs_work( int matrix_layout, char uplo, int n, int nrhs, const double* d, const MKL_Complex16* e, MKL_Complex16* b, int ldb ); int LAPACKE_zspcon( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zspcon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zsprfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zsprfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* afp, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zspsv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zspsv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* ap, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zspsvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zspsvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* afp, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zsptrf( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zsptrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, int* ipiv ); int LAPACKE_zsptri( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv ); int LAPACKE_zsptri_work( int matrix_layout, char uplo, int n, MKL_Complex16* ap, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zsptrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsptrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* ap, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zstedc( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz ); int LAPACKE_zstedc_work( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zstegr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz ); int LAPACKE_zstegr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_zstein( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, int ldz, int* ifailv ); int LAPACKE_zstein_work( int matrix_layout, int n, const double* d, const double* e, int m, const double* w, const int* iblock, const int* isplit, MKL_Complex16* z, int ldz, double* work, int* iwork, int* ifailv ); int LAPACKE_zstemr( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, MKL_Complex16* z, int ldz, int nzc, int* isuppz, int* tryrac ); int LAPACKE_zstemr_work( int matrix_layout, char jobz, char range, int n, double* d, double* e, double vl, double vu, int il, int iu, int* m, double* w, MKL_Complex16* z, int ldz, int nzc, int* isuppz, int* tryrac, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_zsteqr( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz ); int LAPACKE_zsteqr_work( int matrix_layout, char compz, int n, double* d, double* e, MKL_Complex16* z, int ldz, double* work ); int LAPACKE_zsycon( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zsycon_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zsyconv( int matrix_layout, char uplo, char way, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* e ); int LAPACKE_zsyconv_work( int matrix_layout, char uplo, char way, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* e ); int LAPACKE_zsyequb( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax ); int LAPACKE_zsyequb_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, double* s, double* scond, double* amax, MKL_Complex16* work ); int LAPACKE_zsyr( int matrix_layout, char uplo, int n, MKL_Complex16 alpha, const MKL_Complex16* x, int incx, MKL_Complex16* a, int lda ); int LAPACKE_zsyr_work( int matrix_layout, char uplo, int n, MKL_Complex16 alpha, const MKL_Complex16* x, int incx, MKL_Complex16* a, int lda ); int LAPACKE_zsyrfs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_zsyrfs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_zsyrfsx( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zsyrfsx_work( int matrix_layout, char uplo, char equed, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* af, int ldaf, const int* ipiv, const double* s, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zsysv( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_rook( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_rook_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsysv_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsysvx( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr ); int LAPACKE_zsysvx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, const MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* ferr, double* berr, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zsysvxx( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params ); int LAPACKE_zsysvxx_work( int matrix_layout, char fact, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* af, int ldaf, int* ipiv, char* equed, double* s, MKL_Complex16* b, int ldb, MKL_Complex16* x, int ldx, double* rcond, double* rpvgrw, double* berr, int n_err_bnds, double* err_bnds_norm, double* err_bnds_comp, int nparams, double* params, MKL_Complex16* work, double* rwork ); int LAPACKE_zsyswapr( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zsyswapr_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int i1, int i2 ); int LAPACKE_zsytrf( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zsytrf_rook( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zsytrf_rook_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrf_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytri( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zsytri2( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv ); int LAPACKE_zsytri2_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytri2x( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, int nb ); int LAPACKE_zsytri2x_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work, int nb ); int LAPACKE_zsytri_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* work ); int LAPACKE_zsytrs( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs2( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs2_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work ); int LAPACKE_zsytrs_rook( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_rook_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_ztbcon( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex16* ab, int ldab, double* rcond ); int LAPACKE_ztbcon_work( int matrix_layout, char norm, char uplo, char diag, int n, int kd, const MKL_Complex16* ab, int ldab, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_ztbrfs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_ztbrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_ztbtrs( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_ztbtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int kd, int nrhs, const MKL_Complex16* ab, int ldab, MKL_Complex16* b, int ldb ); int LAPACKE_ztfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex16 alpha, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_ztfsm_work( int matrix_layout, char transr, char side, char uplo, char trans, char diag, int m, int n, MKL_Complex16 alpha, const MKL_Complex16* a, MKL_Complex16* b, int ldb ); int LAPACKE_ztftri( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex16* a ); int LAPACKE_ztftri_work( int matrix_layout, char transr, char uplo, char diag, int n, MKL_Complex16* a ); int LAPACKE_ztfttp( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* ap ); int LAPACKE_ztfttp_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* ap ); int LAPACKE_ztfttr( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* a, int lda ); int LAPACKE_ztfttr_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* arf, MKL_Complex16* a, int lda ); int LAPACKE_ztgevc( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex16* s, int lds, const MKL_Complex16* p, int ldp, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m ); int LAPACKE_ztgevc_work( int matrix_layout, char side, char howmny, const int* select, int n, const MKL_Complex16* s, int lds, const MKL_Complex16* p, int ldp, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, MKL_Complex16* work, double* rwork ); int LAPACKE_ztgexc( int matrix_layout, int wantq, int wantz, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int ifst, int ilst ); int LAPACKE_ztgexc_work( int matrix_layout, int wantq, int wantz, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int ifst, int ilst ); int LAPACKE_ztgsen( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int* m, double* pl, double* pr, double* dif ); int LAPACKE_ztgsen_work( int matrix_layout, int ijob, int wantq, int wantz, const int* select, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* alpha, MKL_Complex16* beta, MKL_Complex16* q, int ldq, MKL_Complex16* z, int ldz, int* m, double* pl, double* pr, double* dif, MKL_Complex16* work, int lwork, int* iwork, int liwork ); int LAPACKE_ztgsja( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, int* ncycle ); int LAPACKE_ztgsja_work( int matrix_layout, char jobu, char jobv, char jobq, int m, int p, int n, int k, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double tola, double tolb, double* alpha, double* beta, MKL_Complex16* u, int ldu, MKL_Complex16* v, int ldv, MKL_Complex16* q, int ldq, MKL_Complex16* work, int* ncycle ); int LAPACKE_ztgsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* dif, int mm, int* m ); int LAPACKE_ztgsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* dif, int mm, int* m, MKL_Complex16* work, int lwork, int* iwork ); int LAPACKE_ztgsyl( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, const MKL_Complex16* d, int ldd, const MKL_Complex16* e, int lde, MKL_Complex16* f, int ldf, double* scale, double* dif ); int LAPACKE_ztgsyl_work( int matrix_layout, char trans, int ijob, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, const MKL_Complex16* d, int ldd, const MKL_Complex16* e, int lde, MKL_Complex16* f, int ldf, double* scale, double* dif, MKL_Complex16* work, int lwork, int* iwork ); int LAPACKE_ztpcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* ap, double* rcond ); int LAPACKE_ztpcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* ap, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_ztpmqrt( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_ztpmqrt_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, int nb, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work ); int LAPACKE_ztpqrt( int matrix_layout, int m, int n, int l, int nb, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt ); int LAPACKE_ztpqrt2( int matrix_layout, int m, int n, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt ); int LAPACKE_ztpqrt2_work( int matrix_layout, int m, int n, int l, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt ); int LAPACKE_ztpqrt_work( int matrix_layout, int m, int n, int l, int nb, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* t, int ldt, MKL_Complex16* work ); int LAPACKE_ztprfb( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb); int LAPACKE_ztprfb_work( int matrix_layout, char side, char trans, char direct, char storev, int m, int n, int k, int l, const MKL_Complex16* v, int ldv, const MKL_Complex16* t, int ldt, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work, int ldwork ); int LAPACKE_ztprfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_ztprfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_ztptri( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* ap ); int LAPACKE_ztptri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* ap ); int LAPACKE_ztptrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_ztptrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* ap, MKL_Complex16* b, int ldb ); int LAPACKE_ztpttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* arf ); int LAPACKE_ztpttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* arf ); int LAPACKE_ztpttr( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* a, int lda ); int LAPACKE_ztpttr_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, MKL_Complex16* a, int lda ); int LAPACKE_ztrcon( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* a, int lda, double* rcond ); int LAPACKE_ztrcon_work( int matrix_layout, char norm, char uplo, char diag, int n, const MKL_Complex16* a, int lda, double* rcond, MKL_Complex16* work, double* rwork ); int LAPACKE_ztrevc( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m ); int LAPACKE_ztrevc_work( int matrix_layout, char side, char howmny, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* vl, int ldvl, MKL_Complex16* vr, int ldvr, int mm, int* m, MKL_Complex16* work, double* rwork ); int LAPACKE_ztrexc( int matrix_layout, char compq, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, int ifst, int ilst ); int LAPACKE_ztrexc_work( int matrix_layout, char compq, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, int ifst, int ilst ); int LAPACKE_ztrrfs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr ); int LAPACKE_ztrrfs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, const MKL_Complex16* x, int ldx, double* ferr, double* berr, MKL_Complex16* work, double* rwork ); int LAPACKE_ztrsen( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, MKL_Complex16* w, int* m, double* s, double* sep ); int LAPACKE_ztrsen_work( int matrix_layout, char job, char compq, const int* select, int n, MKL_Complex16* t, int ldt, MKL_Complex16* q, int ldq, MKL_Complex16* w, int* m, double* s, double* sep, MKL_Complex16* work, int lwork ); int LAPACKE_ztrsna( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* t, int ldt, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* sep, int mm, int* m ); int LAPACKE_ztrsna_work( int matrix_layout, char job, char howmny, const int* select, int n, const MKL_Complex16* t, int ldt, const MKL_Complex16* vl, int ldvl, const MKL_Complex16* vr, int ldvr, double* s, double* sep, int mm, int* m, MKL_Complex16* work, int ldwork, double* rwork ); int LAPACKE_ztrsyl( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, double* scale ); int LAPACKE_ztrsyl_work( int matrix_layout, char trana, char tranb, int isgn, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* b, int ldb, MKL_Complex16* c, int ldc, double* scale ); int LAPACKE_ztrtri( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* a, int lda ); int LAPACKE_ztrtri_work( int matrix_layout, char uplo, char diag, int n, MKL_Complex16* a, int lda ); int LAPACKE_ztrtrs( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_ztrtrs_work( int matrix_layout, char uplo, char trans, char diag, int n, int nrhs, const MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_ztrttf( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* arf ); int LAPACKE_ztrttf_work( int matrix_layout, char transr, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* arf ); int LAPACKE_ztrttp( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* ap ); int LAPACKE_ztrttp_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, MKL_Complex16* ap ); int LAPACKE_ztzrzf( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau ); int LAPACKE_ztzrzf_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunbdb( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2 ); int LAPACKE_zunbdb_work( int matrix_layout, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, double* phi, MKL_Complex16* taup1, MKL_Complex16* taup2, MKL_Complex16* tauq1, MKL_Complex16* tauq2, MKL_Complex16* work, int lwork ); int LAPACKE_zuncsd( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t ); int LAPACKE_zuncsd2by1( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x21, int ldx21, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t ); int LAPACKE_zuncsd2by1_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x21, int ldx21, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork ); int LAPACKE_zuncsd_work( int matrix_layout, char jobu1, char jobu2, char jobv1t, char jobv2t, char trans, char signs, int m, int p, int q, MKL_Complex16* x11, int ldx11, MKL_Complex16* x12, int ldx12, MKL_Complex16* x21, int ldx21, MKL_Complex16* x22, int ldx22, double* theta, MKL_Complex16* u1, int ldu1, MKL_Complex16* u2, int ldu2, MKL_Complex16* v1t, int ldv1t, MKL_Complex16* v2t, int ldv2t, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork ); int LAPACKE_zungbr( int matrix_layout, char vect, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungbr_work( int matrix_layout, char vect, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunghr( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zunghr_work( int matrix_layout, int n, int ilo, int ihi, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunglq( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zunglq_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungql( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungql_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungqr( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungqr_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungrq( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungrq_work( int matrix_layout, int m, int n, int k, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zungtr( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* tau ); int LAPACKE_zungtr_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* work, int lwork ); int LAPACKE_zunmbr( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmbr_work( int matrix_layout, char vect, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmhr( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmhr_work( int matrix_layout, char side, char trans, int m, int n, int ilo, int ihi, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmql( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmql_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmrq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmrq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmrz( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmrz_work( int matrix_layout, char side, char trans, int m, int n, int k, int l, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zunmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zunmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zupgtr( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, int ldq ); int LAPACKE_zupgtr_work( int matrix_layout, char uplo, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* q, int ldq, MKL_Complex16* work ); int LAPACKE_zupmtr( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, int ldc ); int LAPACKE_zupmtr_work( int matrix_layout, char side, char uplo, char trans, int m, int n, const MKL_Complex16* ap, const MKL_Complex16* tau, MKL_Complex16* c, int ldc, MKL_Complex16* work ); void LAPACKE_ilaver( int* vers_major, int* vers_minor, int* vers_patch ); void LAPACKE_xerbla( const char *name, int info ); int LAPACKE_chesv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chesv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf_aa( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_chetrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_dsysv_aa( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsytrf_aa( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv ); int LAPACKE_dsytrf_aa_work( int matrix_layout, char uplo, int n, double* a, int lda, int* ipiv, double* work, int lwork ); int LAPACKE_dsytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_ssysv_aa( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssytrf_aa( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv ); int LAPACKE_ssytrf_aa_work( int matrix_layout, char uplo, int n, float* a, int lda, int* ipiv, float* work, int lwork ); int LAPACKE_ssytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_zhesv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhesv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf_aa( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zhetrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_cgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc ); int LAPACKE_cgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_cgeqr( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize ); int LAPACKE_cgeqr_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize, MKL_Complex8* work, int lwork ); int LAPACKE_dgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc ); int LAPACKE_dgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc, double* work, int lwork ); int LAPACKE_dgeqr( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize ); int LAPACKE_dgeqr_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize, double* work, int lwork ); int LAPACKE_sgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc ); int LAPACKE_sgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc, float* work, int lwork ); int LAPACKE_sgeqr( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize ); int LAPACKE_sgeqr_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize, float* work, int lwork ); int LAPACKE_zgemqr( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc ); int LAPACKE_zgemqr_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_zgeqr( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize ); int LAPACKE_zgeqr_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize, MKL_Complex16* work, int lwork ); int LAPACKE_cgelq( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize ); int LAPACKE_cgelq_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda, MKL_Complex8* t, int tsize, MKL_Complex8* work, int lwork ); int LAPACKE_cgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc ); int LAPACKE_cgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex8* a, int lda, const MKL_Complex8* t, int tsize, MKL_Complex8* c, int ldc, MKL_Complex8* work, int lwork ); int LAPACKE_dgelq( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize ); int LAPACKE_dgelq_work( int matrix_layout, int m, int n, double* a, int lda, double* t, int tsize, double* work, int lwork ); int LAPACKE_dgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc ); int LAPACKE_dgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const double* a, int lda, const double* t, int tsize, double* c, int ldc, double* work, int lwork ); int LAPACKE_sgelq( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize ); int LAPACKE_sgelq_work( int matrix_layout, int m, int n, float* a, int lda, float* t, int tsize, float* work, int lwork ); int LAPACKE_sgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc ); int LAPACKE_sgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const float* a, int lda, const float* t, int tsize, float* c, int ldc, float* work, int lwork ); int LAPACKE_zgelq( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize ); int LAPACKE_zgelq_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda, MKL_Complex16* t, int tsize, MKL_Complex16* work, int lwork ); int LAPACKE_zgemlq( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc ); int LAPACKE_zgemlq_work( int matrix_layout, char side, char trans, int m, int n, int k, const MKL_Complex16* a, int lda, const MKL_Complex16* t, int tsize, MKL_Complex16* c, int ldc, MKL_Complex16* work, int lwork ); int LAPACKE_cgetsls( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb ); int LAPACKE_cgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_dgetsls( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb ); int LAPACKE_dgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, double* a, int lda, double* b, int ldb, double* work, int lwork ); int LAPACKE_sgetsls( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb ); int LAPACKE_sgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, float* a, int lda, float* b, int ldb, float* work, int lwork ); int LAPACKE_zgetsls( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb ); int LAPACKE_zgetsls_work( int matrix_layout, char trans, int m, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_checon_3( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond ); int LAPACKE_checon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_chesv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chesv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_chetrf_rk( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv ); int LAPACKE_chetrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetri_3( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv ); int LAPACKE_chetri_3_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_chetrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_chetrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csycon_3( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond ); int LAPACKE_csycon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, float anorm, float* rcond, MKL_Complex8* work ); int LAPACKE_csysv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csysv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_csytrf_aa( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv ); int LAPACKE_csytrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytrf_rk( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv ); int LAPACKE_csytrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* e, int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytri_3( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv ); int LAPACKE_csytri_3_work( int matrix_layout, char uplo, int n, MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* work, int lwork ); int LAPACKE_csytrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const MKL_Complex8* e, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb ); int LAPACKE_csytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex8* a, int lda, const int* ipiv, MKL_Complex8* b, int ldb, MKL_Complex8* work, int lwork ); int LAPACKE_dsycon_3( int matrix_layout, char uplo, int n, const double* a, int lda, const double* e, const int* ipiv, double anorm, double* rcond ); int LAPACKE_dsycon_3_work( int matrix_layout, char uplo, int n, const double* a, int lda, const double* e, const int* ipiv, double anorm, double* rcond, double* work, int* iwork ); int LAPACKE_dsysv_rk( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* e, int* ipiv, double* b, int ldb ); int LAPACKE_dsysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, double* a, int lda, double* e, int* ipiv, double* b, int ldb, double* work, int lwork ); int LAPACKE_dsytrf_rk( int matrix_layout, char uplo, int n, double* a, int lda, double* e, int* ipiv ); int LAPACKE_dsytrf_rk_work( int matrix_layout, char uplo, int n, double* a, int lda, double* e, int* ipiv, double* work, int lwork ); int LAPACKE_dsytri_3( int matrix_layout, char uplo, int n, double* a, int lda, const double* e, const int* ipiv ); int LAPACKE_dsytri_3_work( int matrix_layout, char uplo, int n, double* a, int lda, const double* e, const int* ipiv, double* work, int lwork ); int LAPACKE_dsytrs_3( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* e, const int* ipiv, double* b, int ldb ); int LAPACKE_dsytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const double* a, int lda, const double* e, const int* ipiv, double* b, int ldb ); int LAPACKE_ssycon_3( int matrix_layout, char uplo, int n, const float* a, int lda, const float* e, const int* ipiv, float anorm, float* rcond ); int LAPACKE_ssycon_3_work( int matrix_layout, char uplo, int n, const float* a, int lda, const float* e, const int* ipiv, float anorm, float* rcond, float* work, int* iwork ); int LAPACKE_ssysv_rk( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* e, int* ipiv, float* b, int ldb ); int LAPACKE_ssysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, float* a, int lda, float* e, int* ipiv, float* b, int ldb, float* work, int lwork ); int LAPACKE_ssytrf_rk( int matrix_layout, char uplo, int n, float* a, int lda, float* e, int* ipiv ); int LAPACKE_ssytrf_rk_work( int matrix_layout, char uplo, int n, float* a, int lda, float* e, int* ipiv, float* work, int lwork ); int LAPACKE_ssytri_3( int matrix_layout, char uplo, int n, float* a, int lda, const float* e, const int* ipiv ); int LAPACKE_ssytri_3_work( int matrix_layout, char uplo, int n, float* a, int lda, const float* e, const int* ipiv, float* work, int lwork ); int LAPACKE_ssytrs_3( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* e, const int* ipiv, float* b, int ldb ); int LAPACKE_ssytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const float* a, int lda, const float* e, const int* ipiv, float* b, int ldb ); int LAPACKE_zhecon_3( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zhecon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zhesv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhesv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrf_rk( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv ); int LAPACKE_zhetrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetri_3( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv ); int LAPACKE_zhetri_3_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zhetrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zhetrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsycon_3( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond ); int LAPACKE_zsycon_3_work( int matrix_layout, char uplo, int n, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, double anorm, double* rcond, MKL_Complex16* work ); int LAPACKE_zsysv_aa( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_aa_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsysv_rk( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsysv_rk_work( int matrix_layout, char uplo, int n, int nrhs, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrf_aa( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv ); int LAPACKE_zsytrf_aa_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrf_rk( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv ); int LAPACKE_zsytrf_rk_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* e, int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytri_3( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv ); int LAPACKE_zsytri_3_work( int matrix_layout, char uplo, int n, MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* work, int lwork ); int LAPACKE_zsytrs_3( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_3_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const MKL_Complex16* e, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_aa( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb ); int LAPACKE_zsytrs_aa_work( int matrix_layout, char uplo, int n, int nrhs, const MKL_Complex16* a, int lda, const int* ipiv, MKL_Complex16* b, int ldb, MKL_Complex16* work, int lwork ); int LAPACKE_chbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_chbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz ); int LAPACKE_chbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_chbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_chbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex8* ab, int ldab, MKL_Complex8* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_cheev_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheev_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_cheevd_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w ); int LAPACKE_cheevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex8* a, int lda, float* w, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz ); int LAPACKE_cheevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* isuppz, MKL_Complex8* work, int lwork, float* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_cheevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, int* ifail ); int LAPACKE_cheevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex8* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, MKL_Complex8* z, int ldz, MKL_Complex8* work, int lwork, float* rwork, int* iwork, int* ifail ); int LAPACKE_chegv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w ); int LAPACKE_chegv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex8* a, int lda, MKL_Complex8* b, int ldb, float* w, MKL_Complex8* work, int lwork, float* rwork ); int LAPACKE_dsbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work, int lwork ); int LAPACKE_dsbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz ); int LAPACKE_dsbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, double* ab, int ldab, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, double* ab, int ldab, double* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsyev_2stage( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyev_2stage_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork ); int LAPACKE_dsyevd_2stage( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w ); int LAPACKE_dsyevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, double* a, int lda, double* w, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz ); int LAPACKE_dsyevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* isuppz, double* work, int lwork, int* iwork, int liwork ); int LAPACKE_dsyevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, int* ifail ); int LAPACKE_dsyevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, double* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, double* z, int ldz, double* work, int lwork, int* iwork, int* ifail ); int LAPACKE_dsygv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w ); int LAPACKE_dsygv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, double* a, int lda, double* b, int ldb, double* w, double* work, int lwork ); int LAPACKE_ssbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work, int lwork ); int LAPACKE_ssbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz ); int LAPACKE_ssbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, float* ab, int ldab, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, float* ab, int ldab, float* q, int ldq, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssyev_2stage( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyev_2stage_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork ); int LAPACKE_ssyevd_2stage( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w ); int LAPACKE_ssyevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, float* a, int lda, float* w, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz ); int LAPACKE_ssyevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* isuppz, float* work, int lwork, int* iwork, int liwork ); int LAPACKE_ssyevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, int* ifail ); int LAPACKE_ssyevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, float* a, int lda, float vl, float vu, int il, int iu, float abstol, int* m, float* w, float* z, int ldz, float* work, int lwork, int* iwork, int* ifail ); int LAPACKE_ssygv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w ); int LAPACKE_ssygv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, float* a, int lda, float* b, int ldb, float* w, float* work, int lwork ); int LAPACKE_zhbev_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbev_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zhbevd_2stage( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz ); int LAPACKE_zhbevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zhbevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zhbevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, int kd, MKL_Complex16* ab, int ldab, MKL_Complex16* q, int ldq, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zheev_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheev_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_zheevd_2stage( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w ); int LAPACKE_zheevd_2stage_work( int matrix_layout, char jobz, char uplo, int n, MKL_Complex16* a, int lda, double* w, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevr_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz ); int LAPACKE_zheevr_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* isuppz, MKL_Complex16* work, int lwork, double* rwork, int lrwork, int* iwork, int liwork ); int LAPACKE_zheevx_2stage( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, int* ifail ); int LAPACKE_zheevx_2stage_work( int matrix_layout, char jobz, char range, char uplo, int n, MKL_Complex16* a, int lda, double vl, double vu, int il, int iu, double abstol, int* m, double* w, MKL_Complex16* z, int ldz, MKL_Complex16* work, int lwork, double* rwork, int* iwork, int* ifail ); int LAPACKE_zhegv_2stage( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w ); int LAPACKE_zhegv_2stage_work( int matrix_layout, int itype, char jobz, char uplo, int n, MKL_Complex16* a, int lda, MKL_Complex16* b, int ldb, double* w, MKL_Complex16* work, int lwork, double* rwork ); int LAPACKE_mkl_cgetrfnp( int matrix_layout, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_mkl_cgetrfnp_work( int matrix_layout, int m, int n, MKL_Complex8* a, int lda ); int LAPACKE_mkl_dgetrfnp( int matrix_layout, int m, int n, double* a, int lda ); int LAPACKE_mkl_dgetrfnp_work( int matrix_layout, int m, int n, double* a, int lda ); int LAPACKE_mkl_sgetrfnp( int matrix_layout, int m, int n, float* a, int lda ); int LAPACKE_mkl_sgetrfnp_work( int matrix_layout, int m, int n, float* a, int lda ); int LAPACKE_mkl_zgetrfnp( int matrix_layout, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_mkl_zgetrfnp_work( int matrix_layout, int m, int n, MKL_Complex16* a, int lda ); int LAPACKE_mkl_cgetrinp( int matrix_layout, int n, MKL_Complex8* a, int lda ); int LAPACKE_mkl_cgetrinp_work( int matrix_layout, int n, MKL_Complex8* a, int lda, MKL_Complex8* work, int lwork ); int LAPACKE_mkl_dgetrinp( int matrix_layout, int n, double* a, int lda ); int LAPACKE_mkl_dgetrinp_work( int matrix_layout, int n, double* a, int lda, double* work, int lwork ); int LAPACKE_mkl_sgetrinp( int matrix_layout, int n, float* a, int lda ); int LAPACKE_mkl_sgetrinp_work( int matrix_layout, int n, float* a, int lda, float* work, int lwork ); int LAPACKE_mkl_zgetrinp( int matrix_layout, int n, MKL_Complex16* a, int lda ); int LAPACKE_mkl_zgetrinp_work( int matrix_layout, int n, MKL_Complex16* a, int lda, MKL_Complex16* work, int lwork ); void LAPACKE_set_nancheck( int flag ); int LAPACKE_get_nancheck( ); #line 45 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_pardiso.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" typedef void * _MKL_DSS_HANDLE_t; typedef char _CHARACTER_t; typedef char _CHARACTER_STR_t; typedef long long _LONG_t; typedef float _REAL_t; typedef double _DOUBLE_PRECISION_t; typedef struct { double r, i; } _DOUBLE_COMPLEX_t; #line 123 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 134 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 145 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 156 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 197 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" extern int __cdecl dss_create_ (_MKL_DSS_HANDLE_t *, int const *); extern int __cdecl dss_define_structure_ (_MKL_DSS_HANDLE_t *, int const *, int const *, int const *, int const *, int const *, int const *); extern int __cdecl dss_reorder_ (_MKL_DSS_HANDLE_t *, int const *, int const *); extern int __cdecl dss_factor_real_ (_MKL_DSS_HANDLE_t *, int const *, void const *); extern int __cdecl dss_factor_complex_ (_MKL_DSS_HANDLE_t *, int const *, void const *); extern int __cdecl dss_solve_real_ (_MKL_DSS_HANDLE_t *, int const *, void const *, int const *, void *); extern int __cdecl dss_solve_complex_ (_MKL_DSS_HANDLE_t *, int const *, void const *, int const *, void *); extern int __cdecl dss_statistics_ ( _MKL_DSS_HANDLE_t *, int const *, _CHARACTER_STR_t const *, _DOUBLE_PRECISION_t *); extern int __cdecl dss_delete_ (_MKL_DSS_HANDLE_t const *, int const *); #line 250 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 271 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dss.h" #line 27 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_pardiso.h" #line 44 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_pardiso.h" extern void __cdecl pardiso ( _MKL_DSS_HANDLE_t, const int *, const int *, const int *, const int *, const int *, const void *, const int *, const int *, int *, const int *, int *, const int *, void *, void *, int *); extern void __cdecl PARDISO ( _MKL_DSS_HANDLE_t, const int *, const int *, const int *, const int *, const int *, const void *, const int *, const int *, int *, const int *, int *, const int *, void *, void *, int *); extern void __cdecl pardisoinit ( _MKL_DSS_HANDLE_t, const int *, int *); extern void __cdecl PARDISOINIT ( _MKL_DSS_HANDLE_t, const int *, int *); extern void __cdecl pardiso_64 ( _MKL_DSS_HANDLE_t, const long long int *, const long long int *, const long long int *, const long long int *, const long long int *, const void *, const long long int *, const long long int *, long long int *, const long long int *, long long int *, const long long int *, void *, void *, long long int *); extern void __cdecl PARDISO_64 ( _MKL_DSS_HANDLE_t, const long long int *, const long long int *, const long long int *, const long long int *, const long long int *, const void *, const long long int *, const long long int *, long long int *, const long long int *, long long int *, const long long int *, void *, void *, long long int *); extern void __cdecl pardiso_handle_store_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_STORE_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_restore_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_RESTORE_64 ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_delete_64 ( const char*, int *);; extern void __cdecl PARDISO_HANDLE_DELETE_64 ( const char*, int *);; enum PARDISO_ENV_PARAM { PARDISO_OOC_FILE_NAME = 1 }; extern int __cdecl pardiso_getenv (const _MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, char*); extern int __cdecl PARDISO_GETENV (const _MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, char*); extern int __cdecl pardiso_setenv (_MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, const char*); extern int __cdecl PARDISO_SETENV (_MKL_DSS_HANDLE_t, const enum PARDISO_ENV_PARAM*, const char*); extern void __cdecl pardiso_handle_store ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_STORE ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_restore ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl PARDISO_HANDLE_RESTORE ( _MKL_DSS_HANDLE_t, const char*, int *);; extern void __cdecl pardiso_handle_delete ( const char*, int *);; extern void __cdecl PARDISO_HANDLE_DELETE ( const char*, int *);; extern int __cdecl MKL_PARDISO_PIVOT ( const double* aii, double* bii, const double* eps ); extern int __cdecl MKL_PARDISO_PIVOT_ ( const double* aii, double* bii, const double* eps ); extern int __cdecl mkl_pardiso_pivot ( const double* aii, double* bii, const double* eps ); extern int __cdecl mkl_pardiso_pivot_ ( const double* aii, double* bii, const double* eps ); extern void __cdecl pardiso_getdiag ( const _MKL_DSS_HANDLE_t, void *, void *, const int *, int * ); extern void __cdecl pardiso_export ( void *, void *, int *, int *, const int *, const int *, int * ); #line 46 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_sparse_handle.h" #line 42 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_sparse_handle.h" typedef enum { MKL_ZERO_BASED, MKL_ONE_BASED } sparse_matrix_indexing; typedef enum { MKL_C_STYLE, MKL_FORTRAN_STYLE } sparse_matrix_print_styles; typedef enum { MKL_CSR } sparse_matrix_formats; typedef enum { MKL_GENERAL_STRUCTURE, MKL_UPPER_TRIANGULAR, MKL_LOWER_TRIANGULAR, MKL_STRUCTURAL_SYMMETRIC } sparse_matrix_structures; typedef enum { MKL_NO_PRINT, MKL_PRINT } sparse_matrix_message_levels; typedef enum { MKL_SPARSE_CHECKER_SUCCESS = 0, MKL_SPARSE_CHECKER_NON_MONOTONIC = 21, MKL_SPARSE_CHECKER_OUT_OF_RANGE = 22, MKL_SPARSE_CHECKER_NONTRIANGULAR = 23, MKL_SPARSE_CHECKER_NONORDERED = 24} sparse_checker_error_values; typedef struct _sparse_struct { int n, *csr_ia, *csr_ja, check_result[3]; sparse_matrix_indexing indexing; sparse_matrix_structures matrix_structure; sparse_matrix_formats matrix_format; sparse_matrix_message_levels message_level; sparse_matrix_print_styles print_style; } sparse_struct; extern void __cdecl sparse_matrix_checker_init (sparse_struct*); extern sparse_checker_error_values __cdecl sparse_matrix_checker (sparse_struct*); #line 47 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_rci.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" #pragma once __pragma(pack(push, 8)) #line 52 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __declspec(allocator) __declspec(restrict) void* __cdecl _calloc_base( size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl calloc( size_t _Count, size_t _Size ); int __cdecl _callnewh( size_t _Size ); __declspec(allocator) void* __cdecl _expand( void* _Block, size_t _Size ); void __cdecl _free_base( void* _Block ); void __cdecl free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _malloc_base( size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl malloc( size_t _Size ); size_t __cdecl _msize_base( void* _Block ); size_t __cdecl _msize( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _realloc_base( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl realloc( void* _Block, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc_base( void* _Block, size_t _Count, size_t _Size ); __declspec(allocator) __declspec(restrict) void* __cdecl _recalloc( void* _Block, size_t _Count, size_t _Size ); void __cdecl _aligned_free( void* _Block ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_malloc( size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_malloc( size_t _Size, size_t _Alignment, size_t _Offset ); size_t __cdecl _aligned_msize( void* _Block, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_realloc( void* _Block, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_offset_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment, size_t _Offset ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_realloc( void* _Block, size_t _Size, size_t _Alignment ); __declspec(allocator) __declspec(restrict) void* __cdecl _aligned_recalloc( void* _Block, size_t _Count, size_t _Size, size_t _Alignment ); #line 225 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_malloc.h" __pragma(pack(pop)) #line 14 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" #pragma once __pragma(pack(push, 8)) typedef int (__cdecl* _CoreCrtSecureSearchSortCompareFunction)(void*, void const*, void const*); typedef int (__cdecl* _CoreCrtNonSecureSearchSortCompareFunction)(void const*, void const*); void* __cdecl bsearch_s( void const* _Key, void const* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void __cdecl qsort_s( void* _Base, rsize_t _NumOfElements, rsize_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl bsearch( void const* _Key, void const* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void __cdecl qsort( void* _Base, size_t _NumOfElements, size_t _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lfind_s( void const* _Key, void const* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); void* __cdecl _lsearch_s( void const* _Key, void* _Base, unsigned int* _NumOfElements, size_t _SizeOfElements, _CoreCrtSecureSearchSortCompareFunction _CompareFunction, void* _Context ); void* __cdecl _lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); #line 185 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_search.h" __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lfind" ". See online help for details.")) void* __cdecl lfind( void const* _Key, void const* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_lsearch" ". See online help for details.")) void* __cdecl lsearch( void const* _Key, void* _Base, unsigned int* _NumOfElements, unsigned int _SizeOfElements, _CoreCrtNonSecureSearchSortCompareFunction _CompareFunction ); __pragma(pack(pop)) #line 15 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma once __pragma(pack(push, 8)) errno_t __cdecl _itow_s( int _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _itow(int _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ltow_s( long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ltow(long _Value, wchar_t *_Buffer, int _Radix); errno_t __cdecl _ultow_s( unsigned long _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ultow(unsigned long _Value, wchar_t *_Buffer, int _Radix); double __cdecl wcstod( wchar_t const* _String, wchar_t** _EndPtr ); double __cdecl _wcstod_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); long __cdecl wcstol( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long __cdecl _wcstol_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl wcstoll( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); long long __cdecl _wcstoll_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl wcstoul( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long __cdecl _wcstoul_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl wcstoull( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned long long __cdecl _wcstoull_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); long double __cdecl wcstold( wchar_t const* _String, wchar_t** _EndPtr ); long double __cdecl _wcstold_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); float __cdecl wcstof( wchar_t const* _String, wchar_t** _EndPtr ); float __cdecl _wcstof_l( wchar_t const* _String, wchar_t** _EndPtr, _locale_t _Locale ); double __cdecl _wtof( wchar_t const* _String ); double __cdecl _wtof_l( wchar_t const* _String, _locale_t _Locale ); int __cdecl _wtoi( wchar_t const* _String ); int __cdecl _wtoi_l( wchar_t const* _String, _locale_t _Locale ); long __cdecl _wtol( wchar_t const* _String ); long __cdecl _wtol_l( wchar_t const* _String, _locale_t _Locale ); long long __cdecl _wtoll( wchar_t const* _String ); long long __cdecl _wtoll_l( wchar_t const* _String, _locale_t _Locale ); errno_t __cdecl _i64tow_s( __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _i64tow( __int64 _Value, wchar_t* _Buffer, int _Radix ); errno_t __cdecl _ui64tow_s( unsigned __int64 _Value, wchar_t* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64tow_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _ui64tow( unsigned __int64 _Value, wchar_t* _Buffer, int _Radix ); __int64 __cdecl _wtoi64( wchar_t const* _String ); __int64 __cdecl _wtoi64_l( wchar_t const* _String, _locale_t _Locale ); __int64 __cdecl _wcstoi64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); __int64 __cdecl _wcstoi64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _wcstoui64( wchar_t const* _String, wchar_t** _EndPtr, int _Radix ); unsigned __int64 __cdecl _wcstoui64_l( wchar_t const* _String, wchar_t** _EndPtr, int _Radix, _locale_t _Locale ); __declspec(allocator) wchar_t* __cdecl _wfullpath( wchar_t* _Buffer, wchar_t const* _Path, size_t _BufferCount ); errno_t __cdecl _wmakepath_s( wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext ); #line 361 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wmakepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wmakepath( wchar_t *_Buffer, wchar_t const* _Drive, wchar_t const* _Dir, wchar_t const* _Filename, wchar_t const* _Ext); #pragma warning(pop) void __cdecl _wperror( wchar_t const* _ErrorMessage ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsplitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsplitpath( wchar_t const* _FullPath, wchar_t* _Drive, wchar_t* _Dir, wchar_t* _Filename, wchar_t* _Ext ); errno_t __cdecl _wsplitpath_s( wchar_t const* _FullPath, wchar_t* _Drive, size_t _DriveCount, wchar_t* _Dir, size_t _DirCount, wchar_t* _Filename, size_t _FilenameCount, wchar_t* _Ext, size_t _ExtCount ); errno_t __cdecl _wdupenv_s( wchar_t** _Buffer, size_t* _BufferCount, wchar_t const* _VarName ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wdupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t* __cdecl _wgetenv( wchar_t const* _VarName ); errno_t __cdecl _wgetenv_s( size_t* _RequiredCount, wchar_t* _Buffer, size_t _BufferCount, wchar_t const* _VarName ); #line 438 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt_wstdlib.h" int __cdecl _wputenv( wchar_t const* _EnvString ); errno_t __cdecl _wputenv_s( wchar_t const* _Name, wchar_t const* _Value ); errno_t __cdecl _wsearchenv_s( wchar_t const* _Filename, wchar_t const* _VarName, wchar_t* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wsearchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _wsearchenv(wchar_t const* _Filename, wchar_t const* _VarName, wchar_t *_ResultPath); int __cdecl _wsystem( wchar_t const* _Command ); __pragma(pack(pop)) #line 16 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #pragma once __pragma(pack(push, 8)) #line 29 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 43 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 71 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" #line 79 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\limits.h" __pragma(pack(pop)) #line 17 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __pragma(pack(push, 8)) void __cdecl _swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(noreturn) void __cdecl exit( int _Code); __declspec(noreturn) void __cdecl _exit( int _Code); __declspec(noreturn) void __cdecl _Exit( int _Code); __declspec(noreturn) void __cdecl quick_exit( int _Code); __declspec(noreturn) void __cdecl abort(void); unsigned int __cdecl _set_abort_behavior( unsigned int _Flags, unsigned int _Mask ); typedef int (__cdecl* _onexit_t)(void); #line 117 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #line 140 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl atexit(void (__cdecl*)(void)); _onexit_t __cdecl _onexit( _onexit_t _Func); int __cdecl at_quick_exit(void (__cdecl*)(void)); typedef void (__cdecl* _purecall_handler)(void); typedef void (__cdecl* _invalid_parameter_handler)( wchar_t const*, wchar_t const*, wchar_t const*, unsigned int, uintptr_t ); _purecall_handler __cdecl _set_purecall_handler( _purecall_handler _Handler ); _purecall_handler __cdecl _get_purecall_handler(void); _invalid_parameter_handler __cdecl _set_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_invalid_parameter_handler(void); _invalid_parameter_handler __cdecl _set_thread_local_invalid_parameter_handler( _invalid_parameter_handler _Handler ); _invalid_parameter_handler __cdecl _get_thread_local_invalid_parameter_handler(void); #line 199 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl _set_error_mode( int _Mode); int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); unsigned long* __cdecl __doserrno(void); errno_t __cdecl _set_doserrno( unsigned long _Value); errno_t __cdecl _get_doserrno( unsigned long * _Value); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __sys_errlist(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "strerror" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int * __cdecl __sys_nerr(void); void __cdecl perror( char const* _ErrMsg); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_pgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char** __cdecl __p__pgmptr (void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_wpgmptr" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) wchar_t** __cdecl __p__wpgmptr(void); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_get_fmode" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int* __cdecl __p__fmode (void); #line 253 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" errno_t __cdecl _get_pgmptr ( char** _Value); errno_t __cdecl _get_wpgmptr( wchar_t** _Value); errno_t __cdecl _set_fmode ( int _Mode ); errno_t __cdecl _get_fmode ( int* _PMode); typedef struct _div_t { int quot; int rem; } div_t; typedef struct _ldiv_t { long quot; long rem; } ldiv_t; typedef struct _lldiv_t { long long quot; long long rem; } lldiv_t; int __cdecl abs ( int _Number); long __cdecl labs ( long _Number); long long __cdecl llabs ( long long _Number); __int64 __cdecl _abs64( __int64 _Number); unsigned short __cdecl _byteswap_ushort( unsigned short _Number); unsigned long __cdecl _byteswap_ulong ( unsigned long _Number); unsigned __int64 __cdecl _byteswap_uint64( unsigned __int64 _Number); div_t __cdecl div ( int _Numerator, int _Denominator); ldiv_t __cdecl ldiv ( long _Numerator, long _Denominator); lldiv_t __cdecl lldiv( long long _Numerator, long long _Denominator); #pragma warning (push) #pragma warning (disable:6540) unsigned int __cdecl _rotl( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotl( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotl64( unsigned __int64 _Value, int _Shift ); unsigned int __cdecl _rotr( unsigned int _Value, int _Shift ); unsigned long __cdecl _lrotr( unsigned long _Value, int _Shift ); unsigned __int64 __cdecl _rotr64( unsigned __int64 _Value, int _Shift ); #pragma warning (pop) void __cdecl srand( unsigned int _Seed); int __cdecl rand(void); #line 380 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" #pragma pack(push, 4) typedef struct { unsigned char ld[10]; } _LDOUBLE; #pragma pack(pop) #line 410 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" typedef struct { double x; } _CRT_DOUBLE; typedef struct { float f; } _CRT_FLOAT; typedef struct { long double x; } _LONGDOUBLE; #pragma pack(push, 4) typedef struct { unsigned char ld12[12]; } _LDBL12; #pragma pack(pop) double __cdecl atof ( char const* _String); int __cdecl atoi ( char const* _String); long __cdecl atol ( char const* _String); long long __cdecl atoll ( char const* _String); __int64 __cdecl _atoi64( char const* _String); double __cdecl _atof_l ( char const* _String, _locale_t _Locale); int __cdecl _atoi_l ( char const* _String, _locale_t _Locale); long __cdecl _atol_l ( char const* _String, _locale_t _Locale); long long __cdecl _atoll_l ( char const* _String, _locale_t _Locale); __int64 __cdecl _atoi64_l( char const* _String, _locale_t _Locale); int __cdecl _atoflt ( _CRT_FLOAT* _Result, char const* _String); int __cdecl _atodbl ( _CRT_DOUBLE* _Result, char* _String); int __cdecl _atoldbl( _LDOUBLE* _Result, char* _String); int __cdecl _atoflt_l( _CRT_FLOAT* _Result, char const* _String, _locale_t _Locale ); int __cdecl _atodbl_l( _CRT_DOUBLE* _Result, char* _String, _locale_t _Locale ); int __cdecl _atoldbl_l( _LDOUBLE* _Result, char* _String, _locale_t _Locale ); float __cdecl strtof( char const* _String, char** _EndPtr ); float __cdecl _strtof_l( char const* _String, char** _EndPtr, _locale_t _Locale ); double __cdecl strtod( char const* _String, char** _EndPtr ); double __cdecl _strtod_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long double __cdecl strtold( char const* _String, char** _EndPtr ); long double __cdecl _strtold_l( char const* _String, char** _EndPtr, _locale_t _Locale ); long __cdecl strtol( char const* _String, char** _EndPtr, int _Radix ); long __cdecl _strtol_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); long long __cdecl strtoll( char const* _String, char** _EndPtr, int _Radix ); long long __cdecl _strtoll_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long __cdecl strtoul( char const* _String, char** _EndPtr, int _Radix ); unsigned long __cdecl _strtoul_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned long long __cdecl strtoull( char const* _String, char** _EndPtr, int _Radix ); unsigned long long __cdecl _strtoull_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); __int64 __cdecl _strtoi64( char const* _String, char** _EndPtr, int _Radix ); __int64 __cdecl _strtoi64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); unsigned __int64 __cdecl _strtoui64( char const* _String, char** _EndPtr, int _Radix ); unsigned __int64 __cdecl _strtoui64_l( char const* _String, char** _EndPtr, int _Radix, _locale_t _Locale ); errno_t __cdecl _itoa_s( int _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _itoa(int _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _ltoa_s( long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ltoa(long _Value, char *_Buffer, int _Radix); errno_t __cdecl _ultoa_s( unsigned long _Value, char* _Buffer, size_t _BufferCount, int _Radix ); #pragma warning(push) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ultoa(unsigned long _Value, char *_Buffer, int _Radix); #pragma warning(pop) errno_t __cdecl _i64toa_s( __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_i64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _i64toa( __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ui64toa_s( unsigned __int64 _Value, char* _Buffer, size_t _BufferCount, int _Radix ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ui64toa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ui64toa( unsigned __int64 _Value, char* _Buffer, int _Radix ); errno_t __cdecl _ecvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _fcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); errno_t __cdecl _gcvt_s( char* _Buffer, size_t _BufferCount, double _Value, int _DigitCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_gcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl _gcvt( double _Value, int _DigitCount, char* _Buffer ); #line 838 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" int __cdecl ___mb_cur_max_func(void); int __cdecl ___mb_cur_max_l_func(_locale_t _Locale); int __cdecl mblen( char const* _Ch, size_t _MaxCount ); int __cdecl _mblen_l( char const* _Ch, size_t _MaxCount, _locale_t _Locale ); size_t __cdecl _mbstrlen( char const* _String ); size_t __cdecl _mbstrlen_l( char const* _String, _locale_t _Locale ); size_t __cdecl _mbstrnlen( char const* _String, size_t _MaxCount ); size_t __cdecl _mbstrnlen_l( char const* _String, size_t _MaxCount, _locale_t _Locale ); int __cdecl mbtowc( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes ); int __cdecl _mbtowc_l( wchar_t* _DstCh, char const* _SrcCh, size_t _SrcSizeInBytes, _locale_t _Locale ); errno_t __cdecl mbstowcs_s( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "mbstowcs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl mbstowcs( wchar_t *_Dest, char const* _Source, size_t _MaxCount); errno_t __cdecl _mbstowcs_s_l( size_t* _PtNumOfCharConverted, wchar_t* _DstBuf, size_t _SizeInWords, char const* _SrcBuf, size_t _MaxCount, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_mbstowcs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _mbstowcs_l( wchar_t *_Dest, char const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wctomb_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl wctomb( char* _MbCh, wchar_t _WCh ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wctomb_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) int __cdecl _wctomb_l( char* _MbCh, wchar_t _WCh, _locale_t _Locale ); errno_t __cdecl wctomb_s( int* _SizeConverted, char* _MbCh, rsize_t _SizeInBytes, wchar_t _WCh ); errno_t __cdecl _wctomb_s_l( int* _SizeConverted, char* _MbCh, size_t _SizeInBytes, wchar_t _WCh, _locale_t _Locale); errno_t __cdecl wcstombs_s( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "wcstombs_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl wcstombs( char *_Dest, wchar_t const* _Source, size_t _MaxCount); errno_t __cdecl _wcstombs_s_l( size_t* _PtNumOfCharConverted, char* _Dst, size_t _DstSizeInBytes, wchar_t const* _Src, size_t _MaxCountInBytes, _locale_t _Locale ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_wcstombs_s_l" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) size_t __cdecl _wcstombs_l( char *_Dest, wchar_t const* _Source, size_t _MaxCount, _locale_t _Locale); __declspec(allocator) char* __cdecl _fullpath( char* _Buffer, char const* _Path, size_t _BufferCount ); errno_t __cdecl _makepath_s( char* _Buffer, size_t _BufferCount, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext ); #pragma warning(push) #pragma warning(disable: 28719) #pragma warning(disable: 28726) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_makepath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _makepath( char *_Buffer, char const* _Drive, char const* _Dir, char const* _Filename, char const* _Ext); #pragma warning(pop) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_splitpath_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _splitpath( char const* _FullPath, char* _Drive, char* _Dir, char* _Filename, char* _Ext ); errno_t __cdecl _splitpath_s( char const* _FullPath, char* _Drive, size_t _DriveCount, char* _Dir, size_t _DirCount, char* _Filename, size_t _FilenameCount, char* _Ext, size_t _ExtCount ); errno_t __cdecl getenv_s( size_t* _RequiredCount, char* _Buffer, rsize_t _BufferCount, char const* _VarName ); int* __cdecl __p___argc (void); char*** __cdecl __p___argv (void); wchar_t*** __cdecl __p___wargv(void); #line 1164 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" char*** __cdecl __p__environ (void); wchar_t*** __cdecl __p__wenviron(void); #line 1181 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stdlib.h" __declspec(deprecated("This function or variable may be unsafe. Consider using " "_dupenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl getenv( char const* _VarName ); errno_t __cdecl _dupenv_s( char** _Buffer, size_t* _BufferCount, char const* _VarName ); int __cdecl system( char const* _Command ); #pragma warning (push) #pragma warning (disable:6540) int __cdecl _putenv( char const* _EnvString ); errno_t __cdecl _putenv_s( char const* _Name, char const* _Value ); #pragma warning (pop) errno_t __cdecl _searchenv_s( char const* _Filename, char const* _VarName, char* _Buffer, size_t _BufferCount ); __declspec(deprecated("This function or variable may be unsafe. Consider using " "_searchenv_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) void __cdecl _searchenv(char const* _Filename, char const* _VarName, char *_Buffer); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "SetErrorMode" " " "instead. See online help for details.")) void __cdecl _seterrormode( int _Mode ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Beep" " " "instead. See online help for details.")) void __cdecl _beep( unsigned _Frequency, unsigned _Duration ); __declspec(deprecated("This function or variable has been superceded by newer library " "or operating system functionality. Consider using " "Sleep" " " "instead. See online help for details.")) void __cdecl _sleep( unsigned long _Duration ); #pragma warning(push) #pragma warning(disable: 4141) __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ecvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ecvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ecvt( double _Value, int _DigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_fcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl fcvt( double _Value, int _FractionalDigitCount, int* _PtDec, int* _PtSign ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_gcvt" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_fcvt_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl gcvt( double _Value, int _DigitCount, char* _DstBuf ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_itoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_itoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl itoa( int _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ltoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ltoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ltoa( long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_swab" ". See online help for details.")) void __cdecl swab( char* _Buf1, char* _Buf2, int _SizeInBytes ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_ultoa" ". See online help for details.")) __declspec(deprecated("This function or variable may be unsafe. Consider using " "_ultoa_s" " instead. To disable deprecation, use _CRT_SECURE_NO_WARNINGS. " "See online help for details.")) char* __cdecl ultoa( unsigned long _Value, char* _Buffer, int _Radix ); __declspec(deprecated("The POSIX name for this item is deprecated. Instead, use the ISO C " "and C++ conformant name: " "_putenv" ". See online help for details.")) int __cdecl putenv( char const* _EnvString ); #pragma warning(pop) _onexit_t __cdecl onexit( _onexit_t _Func); __pragma(pack(pop)) #line 24 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" extern void __cdecl MKL_Get_Version (MKLVersion *ver); extern void __cdecl MKL_Get_Version_String (char * buffer, int len); extern void __cdecl MKL_Free_Buffers (void); extern void __cdecl MKL_Thread_Free_Buffers (void); extern long long int __cdecl MKL_Mem_Stat (int* nbuffers); extern long long int __cdecl MKL_Peak_Mem_Usage (int reset); extern void* __cdecl MKL_malloc (size_t size, int align); extern void* __cdecl MKL_calloc (size_t num, size_t size, int align); extern void* __cdecl MKL_realloc (void *ptr, size_t size); extern void __cdecl MKL_free (void *ptr); extern int __cdecl MKL_Disable_Fast_MM (void); extern void __cdecl MKL_Get_Cpu_Clocks (unsigned long long int *); extern double __cdecl MKL_Get_Cpu_Frequency (void); extern double __cdecl MKL_Get_Max_Cpu_Frequency (void); extern double __cdecl MKL_Get_Clocks_Frequency (void); extern int __cdecl MKL_Set_Num_Threads_Local (int nth); extern void __cdecl MKL_Set_Num_Threads (int nth); extern int __cdecl MKL_Get_Max_Threads (void); extern void __cdecl MKL_Set_Num_Stripes (int nstripes); extern int __cdecl MKL_Get_Num_Stripes (void); extern int __cdecl MKL_Domain_Set_Num_Threads (int nth, int MKL_DOMAIN); extern int __cdecl MKL_Domain_Get_Max_Threads (int MKL_DOMAIN); extern void __cdecl MKL_Set_Dynamic (int bool_MKL_DYNAMIC); extern int __cdecl MKL_Get_Dynamic (void); #line 124 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" extern int __cdecl MKL_Enable_Instructions (int); #line 135 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_service.h" extern int __cdecl MKL_Set_Interface_Layer (int code); extern int __cdecl MKL_Set_Threading_Layer (int code); typedef void (* XerblaEntry) (const char * Name, const int * Num, const int Len); extern XerblaEntry __cdecl mkl_set_xerbla (XerblaEntry xerbla); typedef int (* ProgressEntry) (int* thread, int* step, char* stage, int stage_len); extern ProgressEntry __cdecl mkl_set_progress (ProgressEntry progress); extern int __cdecl MKL_CBWR_Get (int); extern int __cdecl MKL_CBWR_Set (int); extern int __cdecl MKL_CBWR_Get_Auto_Branch (void); extern int __cdecl MKL_Set_Env_Mode (int); extern int __cdecl MKL_Verbose (int); extern int __cdecl MKL_Verbose_Output_File (char *); typedef void (* MKLExitHandler)(int why); extern void __cdecl MKL_Set_Exit_Handler (MKLExitHandler h);; extern int __cdecl MKL_Set_Memory_Limit (int mem_type,size_t limit);; enum { MKL_BLACS_CUSTOM = 0, MKL_BLACS_MSMPI = 1, MKL_BLACS_INTELMPI = 2, MKL_BLACS_MPICH2 = 3, MKL_BLACS_LASTMPI = 4 }; int MKL_Set_mpi(int vendor, const char *custom_library_name); extern void __cdecl MKL_Finalize (void);; #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_rci.h" #line 38 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_rci.h" extern void __cdecl dcsrilu0 (const int *n, const double *a, const int *ia, const int *ja, double *alu, const int *ipar, const double *dpar,int *ierr); extern void __cdecl dcsrilut (const int *n, const double *a, const int *ia, const int *ja, double *alut,int *ialut, int *jalut, const double * tol, const int *maxfil, const int *ipar, const double *dpar,int *ierr); extern void __cdecl DCSRILU0 (const int *n, const double *a, const int *ia, const int *ja, double *alu, const int *ipar, const double *dpar,int *ierr); extern void __cdecl DCSRILUT (const int *n, const double *a, const int *ia, const int *ja, double *alut,int *ialut, int *jalut, const double * tol, const int *maxfil, const int *ipar, const double *dpar,int *ierr); extern void __cdecl dcg_init (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcg_check (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcg (const int *n, double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcg_get (const int *n, const double *x, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl dcgmrhs_init (const int *n, const double *x, const int* nRhs, const double *b, const int *method, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcgmrhs_check (const int *n, const double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcgmrhs (const int *n, double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dcgmrhs_get (const int *n, const double *x, const int* nRhs, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl dfgmres_init (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dfgmres_check (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dfgmres (const int *n, double *x, double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl dfgmres_get (const int *n, double *x, double *b, int *RCI_request, const int *ipar, const double *dpar, double *tmp, int *itercount); extern void __cdecl DCG_INIT (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCG_CHECK (const int *n, const double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCG (const int *n, double *x, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCG_GET (const int *n, const double *x, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl DCGMRHS_INIT (const int *n, const double *x, const int* nRhs, const double *b, const int *method, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCGMRHS_CHECK (const int *n, const double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCGMRHS (const int *n, double *x, const int* nRhs, const double *b, int *rci_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DCGMRHS_GET (const int *n, const double *x, const int* nRhs, const double *b, const int *rci_request, const int *ipar, const double *dpar, const double *tmp, int *itercount); extern void __cdecl DFGMRES_INIT (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DFGMRES_CHECK (const int *n, const double *x, const double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DFGMRES (const int *n, double *x, double *b, int *RCI_request, int *ipar, double *dpar, double *tmp); extern void __cdecl DFGMRES_GET (const int *n, double *x, double *b, int *RCI_request, const int *ipar, const double *dpar, double *tmp, int *itercount); typedef void* _TRNSP_HANDLE_t; typedef void* _TRNSPBC_HANDLE_t; typedef void* _JACOBIMATRIX_HANDLE_t; typedef void(*USRFCND) (int*,int*,double*,double*); typedef void(*USRFCNXD) (int*,int*,double*,double*,void*); typedef void(*USRFCNS) (int*,int*,float*,float*); typedef void(*USRFCNXS) (int*,int*,float*,float*,void*); extern int __cdecl dtrnlsp_init (_TRNSP_HANDLE_t*, const int*, const int*, const double*, const double*, const int*, const int*, const double*); extern int __cdecl dtrnlsp_check (_TRNSP_HANDLE_t*, const int*, const int*, const double*, const double*, const double*, int*); extern int __cdecl dtrnlsp_solve (_TRNSP_HANDLE_t*, double*, double*, int*); extern int __cdecl dtrnlsp_get (_TRNSP_HANDLE_t*, int*, int*, double*, double*); extern int __cdecl dtrnlsp_delete (_TRNSP_HANDLE_t*); extern int __cdecl dtrnlspbc_init (_TRNSPBC_HANDLE_t*, const int*, const int*, const double*, const double*, const double*, const double*, const int*, const int*, const double*); extern int __cdecl dtrnlspbc_check (_TRNSPBC_HANDLE_t*, const int*, const int*, const double*, const double*, const double*, const double*, const double*, int*); extern int __cdecl dtrnlspbc_solve (_TRNSPBC_HANDLE_t*, double*, double*, int*); extern int __cdecl dtrnlspbc_get (_TRNSPBC_HANDLE_t*, int*, int*, double*, double*); extern int __cdecl dtrnlspbc_delete (_TRNSPBC_HANDLE_t*); extern int __cdecl djacobi_init (_JACOBIMATRIX_HANDLE_t*, const int*, const int*, const double*, const double*, const double*); extern int __cdecl djacobi_solve (_JACOBIMATRIX_HANDLE_t*, double*, double*, int*); extern int __cdecl djacobi_delete (_JACOBIMATRIX_HANDLE_t*); extern int __cdecl djacobi (USRFCND fcn, const int*, const int*, double*, double*, double*); extern int __cdecl djacobix (USRFCNXD fcn, const int*, const int*, double*, double*, double*,void*); extern int __cdecl strnlsp_init (_TRNSP_HANDLE_t*, const int*, const int*, const float*, const float*, const int*, const int*, const float*); extern int __cdecl strnlsp_check (_TRNSP_HANDLE_t*, const int*, const int*, const float*, const float*, const float*, int*); extern int __cdecl strnlsp_solve (_TRNSP_HANDLE_t*, float*, float*, int*); extern int __cdecl strnlsp_get (_TRNSP_HANDLE_t*, int*, int*, float*, float*); extern int __cdecl strnlsp_delete (_TRNSP_HANDLE_t*); extern int __cdecl strnlspbc_init (_TRNSPBC_HANDLE_t*, const int*, const int*, const float*, const float*, const float*, const float*, const int*, const int*, const float*); extern int __cdecl strnlspbc_check (_TRNSPBC_HANDLE_t*, const int*, const int*, const float*, const float*, const float*, const float*, const float*, int*); extern int __cdecl strnlspbc_solve (_TRNSPBC_HANDLE_t*, float*, float*, int*); extern int __cdecl strnlspbc_get (_TRNSPBC_HANDLE_t*, int*, int*, float*, float*); extern int __cdecl strnlspbc_delete (_TRNSPBC_HANDLE_t*); extern int __cdecl sjacobi_init (_JACOBIMATRIX_HANDLE_t*, const int*, const int*, const float*, const float*, const float*); extern int __cdecl sjacobi_solve (_JACOBIMATRIX_HANDLE_t*, float*, float*, int*); extern int __cdecl sjacobi_delete (_JACOBIMATRIX_HANDLE_t*); extern int __cdecl sjacobi (USRFCNS fcn, const int*, const int*, float*, float*, float*); extern int __cdecl sjacobix (USRFCNXS fcn, const int*, const int*, float*, float*, float*,void*); #line 49 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 108 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 168 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 189 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_defines.h" #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_types.h" typedef struct _DefVmlErrorContext { int iCode; int iIndex; double dbA1; double dbA2; double dbR1; double dbR2; char cFuncName[64]; int iFuncNameLen; double dbA1Im; double dbA2Im; double dbR1Im; double dbR2Im; } DefVmlErrorContext; typedef int (*VMLErrorCallBack) (DefVmlErrorContext* pdefVmlErrorContext); #line 32 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_functions.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml_functions.h" extern void __cdecl VSABS (const int *n, const float a[], float r[]); extern void __cdecl VDABS (const int *n, const double a[], double r[]); extern void __cdecl vsabs (const int *n, const float a[], float r[]); extern void __cdecl vdabs (const int *n, const double a[], double r[]); extern void __cdecl vsAbs (const int n, const float a[], float r[]); extern void __cdecl vdAbs (const int n, const double a[], double r[]); extern void __cdecl VMSABS (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDABS (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsabs (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdabs (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAbs (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAbs (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCABS (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl VZABS (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcabs (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzabs (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcAbs (const int n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzAbs (const int n, const MKL_Complex16 a[], double r[]); extern void __cdecl VMCABS (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl VMZABS (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcabs (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl vmzabs (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcAbs (const int n, const MKL_Complex8 a[], float r[], long long int mode); extern void __cdecl vmzAbs (const int n, const MKL_Complex16 a[], double r[], long long int mode); extern void __cdecl VCARG (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl VZARG (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcarg (const int *n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzarg (const int *n, const MKL_Complex16 a[], double r[]); extern void __cdecl vcArg (const int n, const MKL_Complex8 a[], float r[]); extern void __cdecl vzArg (const int n, const MKL_Complex16 a[], double r[]); extern void __cdecl VMCARG (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl VMZARG (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcarg (const int *n, const MKL_Complex8 a[], float r[], long long int *mode); extern void __cdecl vmzarg (const int *n, const MKL_Complex16 a[], double r[], long long int *mode); extern void __cdecl vmcArg (const int n, const MKL_Complex8 a[], float r[], long long int mode); extern void __cdecl vmzArg (const int n, const MKL_Complex16 a[], double r[], long long int mode); extern void __cdecl VSADD (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDADD (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsadd (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdadd (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsAdd (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdAdd (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSADD (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDADD (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsadd (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdadd (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsAdd (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdAdd (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCADD (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZADD (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcadd (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzadd (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcAdd (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzAdd (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCADD (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZADD (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcadd (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzadd (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAdd (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAdd (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSSUB (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDSUB (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vssub (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdsub (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsSub (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdSub (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSSUB (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDSUB (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmssub (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdsub (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsSub (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdSub (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCSUB (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZSUB (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcsub (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzsub (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcSub (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzSub (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCSUB (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSUB (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsub (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsub (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSub (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSub (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSINV (const int *n, const float a[], float r[]); extern void __cdecl VDINV (const int *n, const double a[], double r[]); extern void __cdecl vsinv (const int *n, const float a[], float r[]); extern void __cdecl vdinv (const int *n, const double a[], double r[]); extern void __cdecl vsInv (const int n, const float a[], float r[]); extern void __cdecl vdInv (const int n, const double a[], double r[]); extern void __cdecl VMSINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsinv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdinv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSQRT (const int *n, const float a[], float r[]); extern void __cdecl VDSQRT (const int *n, const double a[], double r[]); extern void __cdecl vssqrt (const int *n, const float a[], float r[]); extern void __cdecl vdsqrt (const int *n, const double a[], double r[]); extern void __cdecl vsSqrt (const int n, const float a[], float r[]); extern void __cdecl vdSqrt (const int n, const double a[], double r[]); extern void __cdecl VMSSQRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSQRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssqrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsqrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSqrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSqrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCSQRT (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZSQRT (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcsqrt (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzsqrt (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcSqrt (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzSqrt (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCSQRT (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSQRT (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsqrt (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsqrt (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSqrt (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSqrt (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSINVSQRT (const int *n, const float a[], float r[]); extern void __cdecl VDINVSQRT (const int *n, const double a[], double r[]); extern void __cdecl vsinvsqrt (const int *n, const float a[], float r[]); extern void __cdecl vdinvsqrt (const int *n, const double a[], double r[]); extern void __cdecl vsInvSqrt (const int n, const float a[], float r[]); extern void __cdecl vdInvSqrt (const int n, const double a[], double r[]); extern void __cdecl VMSINVSQRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDINVSQRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsinvsqrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdinvsqrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsInvSqrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdInvSqrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCBRT (const int *n, const float a[], float r[]); extern void __cdecl VDCBRT (const int *n, const double a[], double r[]); extern void __cdecl vscbrt (const int *n, const float a[], float r[]); extern void __cdecl vdcbrt (const int *n, const double a[], double r[]); extern void __cdecl vsCbrt (const int n, const float a[], float r[]); extern void __cdecl vdCbrt (const int n, const double a[], double r[]); extern void __cdecl VMSCBRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCBRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscbrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcbrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCbrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCbrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSINVCBRT (const int *n, const float a[], float r[]); extern void __cdecl VDINVCBRT (const int *n, const double a[], double r[]); extern void __cdecl vsinvcbrt (const int *n, const float a[], float r[]); extern void __cdecl vdinvcbrt (const int *n, const double a[], double r[]); extern void __cdecl vsInvCbrt (const int n, const float a[], float r[]); extern void __cdecl vdInvCbrt (const int n, const double a[], double r[]); extern void __cdecl VMSINVCBRT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDINVCBRT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsinvcbrt (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdinvcbrt (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsInvCbrt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdInvCbrt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSQR (const int *n, const float a[], float r[]); extern void __cdecl VDSQR (const int *n, const double a[], double r[]); extern void __cdecl vssqr (const int *n, const float a[], float r[]); extern void __cdecl vdsqr (const int *n, const double a[], double r[]); extern void __cdecl vsSqr (const int n, const float a[], float r[]); extern void __cdecl vdSqr (const int n, const double a[], double r[]); extern void __cdecl VMSSQR (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSQR (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssqr (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsqr (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSqr (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSqr (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSEXP (const int *n, const float a[], float r[]); extern void __cdecl VDEXP (const int *n, const double a[], double r[]); extern void __cdecl vsexp (const int *n, const float a[], float r[]); extern void __cdecl vdexp (const int *n, const double a[], double r[]); extern void __cdecl vsExp (const int n, const float a[], float r[]); extern void __cdecl vdExp (const int n, const double a[], double r[]); extern void __cdecl VMSEXP (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXP (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexp (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexp (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExp (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExp (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCEXP (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZEXP (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcexp (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzexp (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcExp (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzExp (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCEXP (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZEXP (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcexp (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzexp (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcExp (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzExp (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSEXP2 (const int *n, const float a[], float r[]); extern void __cdecl VDEXP2 (const int *n, const double a[], double r[]); extern void __cdecl vsexp2 (const int *n, const float a[], float r[]); extern void __cdecl vdexp2 (const int *n, const double a[], double r[]); extern void __cdecl vsExp2 (const int n, const float a[], float r[]); extern void __cdecl vdExp2 (const int n, const double a[], double r[]); extern void __cdecl VMSEXP2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXP2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexp2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexp2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExp2 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExp2 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSEXP10 (const int *n, const float a[], float r[]); extern void __cdecl VDEXP10 (const int *n, const double a[], double r[]); extern void __cdecl vsexp10 (const int *n, const float a[], float r[]); extern void __cdecl vdexp10 (const int *n, const double a[], double r[]); extern void __cdecl vsExp10 (const int n, const float a[], float r[]); extern void __cdecl vdExp10 (const int n, const double a[], double r[]); extern void __cdecl VMSEXP10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXP10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexp10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexp10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExp10 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExp10 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSEXPM1 (const int *n, const float a[], float r[]); extern void __cdecl VDEXPM1 (const int *n, const double a[], double r[]); extern void __cdecl vsexpm1 (const int *n, const float a[], float r[]); extern void __cdecl vdexpm1 (const int *n, const double a[], double r[]); extern void __cdecl vsExpm1 (const int n, const float a[], float r[]); extern void __cdecl vdExpm1 (const int n, const double a[], double r[]); extern void __cdecl VMSEXPM1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXPM1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexpm1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexpm1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExpm1 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExpm1 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLN (const int *n, const float a[], float r[]); extern void __cdecl VDLN (const int *n, const double a[], double r[]); extern void __cdecl vsln (const int *n, const float a[], float r[]); extern void __cdecl vdln (const int *n, const double a[], double r[]); extern void __cdecl vsLn (const int n, const float a[], float r[]); extern void __cdecl vdLn (const int n, const double a[], double r[]); extern void __cdecl VMSLN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsln (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdln (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLn (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLn (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCLN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZLN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcln (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzln (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcLn (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzLn (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCLN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZLN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcln (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzln (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcLn (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzLn (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSLOG2 (const int *n, const float a[], float r[]); extern void __cdecl VDLOG2 (const int *n, const double a[], double r[]); extern void __cdecl vslog2 (const int *n, const float a[], float r[]); extern void __cdecl vdlog2 (const int *n, const double a[], double r[]); extern void __cdecl vsLog2 (const int n, const float a[], float r[]); extern void __cdecl vdLog2 (const int n, const double a[], double r[]); extern void __cdecl VMSLOG2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOG2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslog2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlog2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLog2 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLog2 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLOG10 (const int *n, const float a[], float r[]); extern void __cdecl VDLOG10 (const int *n, const double a[], double r[]); extern void __cdecl vslog10 (const int *n, const float a[], float r[]); extern void __cdecl vdlog10 (const int *n, const double a[], double r[]); extern void __cdecl vsLog10 (const int n, const float a[], float r[]); extern void __cdecl vdLog10 (const int n, const double a[], double r[]); extern void __cdecl VMSLOG10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOG10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslog10 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlog10 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLog10 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLog10 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCLOG10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZLOG10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vclog10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzlog10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcLog10 (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzLog10 (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCLOG10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZLOG10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmclog10 (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzlog10 (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcLog10 (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzLog10 (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSLOG1P (const int *n, const float a[], float r[]); extern void __cdecl VDLOG1P (const int *n, const double a[], double r[]); extern void __cdecl vslog1p (const int *n, const float a[], float r[]); extern void __cdecl vdlog1p (const int *n, const double a[], double r[]); extern void __cdecl vsLog1p (const int n, const float a[], float r[]); extern void __cdecl vdLog1p (const int n, const double a[], double r[]); extern void __cdecl VMSLOG1P (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOG1P (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslog1p (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlog1p (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLog1p (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLog1p (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLOGB (const int *n, const float a[], float r[]); extern void __cdecl VDLOGB (const int *n, const double a[], double r[]); extern void __cdecl vslogb (const int *n, const float a[], float r[]); extern void __cdecl vdlogb (const int *n, const double a[], double r[]); extern void __cdecl vsLogb (const int n, const float a[], float r[]); extern void __cdecl vdLogb (const int n, const double a[], double r[]); extern void __cdecl VMSLOGB (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLOGB (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslogb (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlogb (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLogb (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLogb (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCOS (const int *n, const float a[], float r[]); extern void __cdecl VDCOS (const int *n, const double a[], double r[]); extern void __cdecl vscos (const int *n, const float a[], float r[]); extern void __cdecl vdcos (const int *n, const double a[], double r[]); extern void __cdecl vsCos (const int n, const float a[], float r[]); extern void __cdecl vdCos (const int n, const double a[], double r[]); extern void __cdecl VMSCOS (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCOS (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscos (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcos (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCos (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCos (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCCOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZCOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vccos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzcos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcCos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzCos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCCOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmccos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzcos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcCos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzCos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSSIN (const int *n, const float a[], float r[]); extern void __cdecl VDSIN (const int *n, const double a[], double r[]); extern void __cdecl vssin (const int *n, const float a[], float r[]); extern void __cdecl vdsin (const int *n, const double a[], double r[]); extern void __cdecl vsSin (const int n, const float a[], float r[]); extern void __cdecl vdSin (const int n, const double a[], double r[]); extern void __cdecl VMSSIN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSIN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssin (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsin (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSin (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSin (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCSIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZSIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcsin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzsin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcSin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzSin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCSIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSTAN (const int *n, const float a[], float r[]); extern void __cdecl VDTAN (const int *n, const double a[], double r[]); extern void __cdecl vstan (const int *n, const float a[], float r[]); extern void __cdecl vdtan (const int *n, const double a[], double r[]); extern void __cdecl vsTan (const int n, const float a[], float r[]); extern void __cdecl vdTan (const int n, const double a[], double r[]); extern void __cdecl VMSTAN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTAN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstan (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtan (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTan (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTan (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCTAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZTAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vctan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vztan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcTan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzTan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCTAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZTAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmctan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmztan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcTan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzTan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSCOSPI (const int *n, const float a[], float r[]); extern void __cdecl VDCOSPI (const int *n, const double a[], double r[]); extern void __cdecl vscospi (const int *n, const float a[], float r[]); extern void __cdecl vdcospi (const int *n, const double a[], double r[]); extern void __cdecl vsCospi (const int n, const float a[], float r[]); extern void __cdecl vdCospi (const int n, const double a[], double r[]); extern void __cdecl VMSCOSPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscospi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCospi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCospi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSINPI (const int *n, const float a[], float r[]); extern void __cdecl VDSINPI (const int *n, const double a[], double r[]); extern void __cdecl vssinpi (const int *n, const float a[], float r[]); extern void __cdecl vdsinpi (const int *n, const double a[], double r[]); extern void __cdecl vsSinpi (const int n, const float a[], float r[]); extern void __cdecl vdSinpi (const int n, const double a[], double r[]); extern void __cdecl VMSSINPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssinpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSinpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSinpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTANPI (const int *n, const float a[], float r[]); extern void __cdecl VDTANPI (const int *n, const double a[], double r[]); extern void __cdecl vstanpi (const int *n, const float a[], float r[]); extern void __cdecl vdtanpi (const int *n, const double a[], double r[]); extern void __cdecl vsTanpi (const int n, const float a[], float r[]); extern void __cdecl vdTanpi (const int n, const double a[], double r[]); extern void __cdecl VMSTANPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstanpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTanpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTanpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCOSD (const int *n, const float a[], float r[]); extern void __cdecl VDCOSD (const int *n, const double a[], double r[]); extern void __cdecl vscosd (const int *n, const float a[], float r[]); extern void __cdecl vdcosd (const int *n, const double a[], double r[]); extern void __cdecl vsCosd (const int n, const float a[], float r[]); extern void __cdecl vdCosd (const int n, const double a[], double r[]); extern void __cdecl VMSCOSD (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCosd (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscosd (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcosd (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCosd (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCosd (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSSIND (const int *n, const float a[], float r[]); extern void __cdecl VDSIND (const int *n, const double a[], double r[]); extern void __cdecl vssind (const int *n, const float a[], float r[]); extern void __cdecl vdsind (const int *n, const double a[], double r[]); extern void __cdecl vsSind (const int n, const float a[], float r[]); extern void __cdecl vdSind (const int n, const double a[], double r[]); extern void __cdecl VMSSIND (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSind (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssind (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsind (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSind (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSind (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTAND (const int *n, const float a[], float r[]); extern void __cdecl VDTAND (const int *n, const double a[], double r[]); extern void __cdecl vstand (const int *n, const float a[], float r[]); extern void __cdecl vdtand (const int *n, const double a[], double r[]); extern void __cdecl vsTand (const int n, const float a[], float r[]); extern void __cdecl vdTand (const int n, const double a[], double r[]); extern void __cdecl VMSTAND (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTand (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstand (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtand (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTand (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTand (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCOSH (const int *n, const float a[], float r[]); extern void __cdecl VDCOSH (const int *n, const double a[], double r[]); extern void __cdecl vscosh (const int *n, const float a[], float r[]); extern void __cdecl vdcosh (const int *n, const double a[], double r[]); extern void __cdecl vsCosh (const int n, const float a[], float r[]); extern void __cdecl vdCosh (const int n, const double a[], double r[]); extern void __cdecl VMSCOSH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCOSH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscosh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcosh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCosh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCosh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCCOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZCOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vccosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzcosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcCosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzCosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCCOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmccosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzcosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcCosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzCosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSSINH (const int *n, const float a[], float r[]); extern void __cdecl VDSINH (const int *n, const double a[], double r[]); extern void __cdecl vssinh (const int *n, const float a[], float r[]); extern void __cdecl vdsinh (const int *n, const double a[], double r[]); extern void __cdecl vsSinh (const int n, const float a[], float r[]); extern void __cdecl vdSinh (const int n, const double a[], double r[]); extern void __cdecl VMSSINH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDSINH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmssinh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdsinh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsSinh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdSinh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCSINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZSINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcsinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzsinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcSinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzSinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCSINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZSINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcsinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzsinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcSinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzSinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSTANH (const int *n, const float a[], float r[]); extern void __cdecl VDTANH (const int *n, const double a[], double r[]); extern void __cdecl vstanh (const int *n, const float a[], float r[]); extern void __cdecl vdtanh (const int *n, const double a[], double r[]); extern void __cdecl vsTanh (const int n, const float a[], float r[]); extern void __cdecl vdTanh (const int n, const double a[], double r[]); extern void __cdecl VMSTANH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTANH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstanh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtanh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTanh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTanh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCTANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZTANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vctanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vztanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcTanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzTanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCTANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZTANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmctanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmztanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcTanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzTanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSACOS (const int *n, const float a[], float r[]); extern void __cdecl VDACOS (const int *n, const double a[], double r[]); extern void __cdecl vsacos (const int *n, const float a[], float r[]); extern void __cdecl vdacos (const int *n, const double a[], double r[]); extern void __cdecl vsAcos (const int n, const float a[], float r[]); extern void __cdecl vdAcos (const int n, const double a[], double r[]); extern void __cdecl VMSACOS (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDACOS (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsacos (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdacos (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAcos (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAcos (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCACOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZACOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcacos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzacos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAcos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAcos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCACOS (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZACOS (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcacos (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzacos (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAcos (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAcos (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSASIN (const int *n, const float a[], float r[]); extern void __cdecl VDASIN (const int *n, const double a[], double r[]); extern void __cdecl vsasin (const int *n, const float a[], float r[]); extern void __cdecl vdasin (const int *n, const double a[], double r[]); extern void __cdecl vsAsin (const int n, const float a[], float r[]); extern void __cdecl vdAsin (const int n, const double a[], double r[]); extern void __cdecl VMSASIN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDASIN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsasin (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdasin (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAsin (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAsin (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCASIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZASIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcasin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzasin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAsin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAsin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCASIN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZASIN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcasin (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzasin (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAsin (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAsin (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSATAN (const int *n, const float a[], float r[]); extern void __cdecl VDATAN (const int *n, const double a[], double r[]); extern void __cdecl vsatan (const int *n, const float a[], float r[]); extern void __cdecl vdatan (const int *n, const double a[], double r[]); extern void __cdecl vsAtan (const int n, const float a[], float r[]); extern void __cdecl vdAtan (const int n, const double a[], double r[]); extern void __cdecl VMSATAN (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDATAN (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsatan (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdatan (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAtan (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAtan (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCATAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZATAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcatan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzatan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAtan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAtan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCATAN (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZATAN (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcatan (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzatan (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAtan (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAtan (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSACOSPI (const int *n, const float a[], float r[]); extern void __cdecl VDACOSPI (const int *n, const double a[], double r[]); extern void __cdecl vsacospi (const int *n, const float a[], float r[]); extern void __cdecl vdacospi (const int *n, const double a[], double r[]); extern void __cdecl vsAcospi (const int n, const float a[], float r[]); extern void __cdecl vdAcospi (const int n, const double a[], double r[]); extern void __cdecl VMSACOSPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDAcospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsacospi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdacospi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAcospi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAcospi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSASINPI (const int *n, const float a[], float r[]); extern void __cdecl VDASINPI (const int *n, const double a[], double r[]); extern void __cdecl vsasinpi (const int *n, const float a[], float r[]); extern void __cdecl vdasinpi (const int *n, const double a[], double r[]); extern void __cdecl vsAsinpi (const int n, const float a[], float r[]); extern void __cdecl vdAsinpi (const int n, const double a[], double r[]); extern void __cdecl VMSASINPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDAsinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsasinpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdasinpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAsinpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAsinpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSATANPI (const int *n, const float a[], float r[]); extern void __cdecl VDATANPI (const int *n, const double a[], double r[]); extern void __cdecl vsatanpi (const int *n, const float a[], float r[]); extern void __cdecl vdatanpi (const int *n, const double a[], double r[]); extern void __cdecl vsAtanpi (const int n, const float a[], float r[]); extern void __cdecl vdAtanpi (const int n, const double a[], double r[]); extern void __cdecl VMSATANPI (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDAtanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsatanpi (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdatanpi (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAtanpi (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAtanpi (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSACOSH (const int *n, const float a[], float r[]); extern void __cdecl VDACOSH (const int *n, const double a[], double r[]); extern void __cdecl vsacosh (const int *n, const float a[], float r[]); extern void __cdecl vdacosh (const int *n, const double a[], double r[]); extern void __cdecl vsAcosh (const int n, const float a[], float r[]); extern void __cdecl vdAcosh (const int n, const double a[], double r[]); extern void __cdecl VMSACOSH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDACOSH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsacosh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdacosh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAcosh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAcosh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCACOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZACOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcacosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzacosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAcosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAcosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCACOSH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZACOSH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcacosh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzacosh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAcosh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAcosh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSASINH (const int *n, const float a[], float r[]); extern void __cdecl VDASINH (const int *n, const double a[], double r[]); extern void __cdecl vsasinh (const int *n, const float a[], float r[]); extern void __cdecl vdasinh (const int *n, const double a[], double r[]); extern void __cdecl vsAsinh (const int n, const float a[], float r[]); extern void __cdecl vdAsinh (const int n, const double a[], double r[]); extern void __cdecl VMSASINH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDASINH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsasinh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdasinh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAsinh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAsinh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCASINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZASINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcasinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzasinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAsinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAsinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCASINH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZASINH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcasinh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzasinh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAsinh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAsinh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSATANH (const int *n, const float a[], float r[]); extern void __cdecl VDATANH (const int *n, const double a[], double r[]); extern void __cdecl vsatanh (const int *n, const float a[], float r[]); extern void __cdecl vdatanh (const int *n, const double a[], double r[]); extern void __cdecl vsAtanh (const int n, const float a[], float r[]); extern void __cdecl vdAtanh (const int n, const double a[], double r[]); extern void __cdecl VMSATANH (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDATANH (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsatanh (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdatanh (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsAtanh (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdAtanh (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCATANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZATANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcatanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzatanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcAtanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzAtanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCATANH (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZATANH (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcatanh (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzatanh (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcAtanh (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzAtanh (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSERF (const int *n, const float a[], float r[]); extern void __cdecl VDERF (const int *n, const double a[], double r[]); extern void __cdecl vserf (const int *n, const float a[], float r[]); extern void __cdecl vderf (const int *n, const double a[], double r[]); extern void __cdecl vsErf (const int n, const float a[], float r[]); extern void __cdecl vdErf (const int n, const double a[], double r[]); extern void __cdecl VMSERF (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERF (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserf (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderf (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErf (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErf (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSERFINV (const int *n, const float a[], float r[]); extern void __cdecl VDERFINV (const int *n, const double a[], double r[]); extern void __cdecl vserfinv (const int *n, const float a[], float r[]); extern void __cdecl vderfinv (const int *n, const double a[], double r[]); extern void __cdecl vsErfInv (const int n, const float a[], float r[]); extern void __cdecl vdErfInv (const int n, const double a[], double r[]); extern void __cdecl VMSERFINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERFINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserfinv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderfinv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErfInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErfInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSHYPOT (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDHYPOT (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vshypot (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdhypot (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsHypot (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdHypot (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSHYPOT (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDHYPOT (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmshypot (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdhypot (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsHypot (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdHypot (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSERFC (const int *n, const float a[], float r[]); extern void __cdecl VDERFC (const int *n, const double a[], double r[]); extern void __cdecl vserfc (const int *n, const float a[], float r[]); extern void __cdecl vderfc (const int *n, const double a[], double r[]); extern void __cdecl vsErfc (const int n, const float a[], float r[]); extern void __cdecl vdErfc (const int n, const double a[], double r[]); extern void __cdecl VMSERFC (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERFC (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserfc (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderfc (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErfc (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErfc (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSERFCINV (const int *n, const float a[], float r[]); extern void __cdecl VDERFCINV (const int *n, const double a[], double r[]); extern void __cdecl vserfcinv (const int *n, const float a[], float r[]); extern void __cdecl vderfcinv (const int *n, const double a[], double r[]); extern void __cdecl vsErfcInv (const int n, const float a[], float r[]); extern void __cdecl vdErfcInv (const int n, const double a[], double r[]); extern void __cdecl VMSERFCINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDERFCINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmserfcinv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmderfcinv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsErfcInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdErfcInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCDFNORM (const int *n, const float a[], float r[]); extern void __cdecl VDCDFNORM (const int *n, const double a[], double r[]); extern void __cdecl vscdfnorm (const int *n, const float a[], float r[]); extern void __cdecl vdcdfnorm (const int *n, const double a[], double r[]); extern void __cdecl vsCdfNorm (const int n, const float a[], float r[]); extern void __cdecl vdCdfNorm (const int n, const double a[], double r[]); extern void __cdecl VMSCDFNORM (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCDFNORM (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscdfnorm (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcdfnorm (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCdfNorm (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCdfNorm (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSCDFNORMINV (const int *n, const float a[], float r[]); extern void __cdecl VDCDFNORMINV (const int *n, const double a[], double r[]); extern void __cdecl vscdfnorminv (const int *n, const float a[], float r[]); extern void __cdecl vdcdfnorminv (const int *n, const double a[], double r[]); extern void __cdecl vsCdfNormInv (const int n, const float a[], float r[]); extern void __cdecl vdCdfNormInv (const int n, const double a[], double r[]); extern void __cdecl VMSCDFNORMINV (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCDFNORMINV (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmscdfnorminv (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdcdfnorminv (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCdfNormInv (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCdfNormInv (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSLGAMMA (const int *n, const float a[], float r[]); extern void __cdecl VDLGAMMA (const int *n, const double a[], double r[]); extern void __cdecl vslgamma (const int *n, const float a[], float r[]); extern void __cdecl vdlgamma (const int *n, const double a[], double r[]); extern void __cdecl vsLGamma (const int n, const float a[], float r[]); extern void __cdecl vdLGamma (const int n, const double a[], double r[]); extern void __cdecl VMSLGAMMA (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDLGAMMA (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmslgamma (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdlgamma (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsLGamma (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdLGamma (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTGAMMA (const int *n, const float a[], float r[]); extern void __cdecl VDTGAMMA (const int *n, const double a[], double r[]); extern void __cdecl vstgamma (const int *n, const float a[], float r[]); extern void __cdecl vdtgamma (const int *n, const double a[], double r[]); extern void __cdecl vsTGamma (const int n, const float a[], float r[]); extern void __cdecl vdTGamma (const int n, const double a[], double r[]); extern void __cdecl VMSTGAMMA (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTGAMMA (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstgamma (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtgamma (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTGamma (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTGamma (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSATAN2 (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDATAN2 (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsatan2 (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdatan2 (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsAtan2 (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdAtan2 (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSATAN2 (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDATAN2 (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsatan2 (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdatan2 (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsAtan2 (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdAtan2 (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSATAN2PI (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDATAN2PI (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsatan2pi (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdatan2pi (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsAtan2pi (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdAtan2pi (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSATAN2PI (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDATAN2PI (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsatan2pi (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdatan2pi (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsAtan2pi (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdAtan2pi (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSMUL (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDMUL (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsmul (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdmul (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsMul (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdMul (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSMUL (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDMUL (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsmul (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdmul (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsMul (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdMul (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCMUL (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZMUL (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcmul (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzmul (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcMul (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzMul (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCMUL (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZMUL (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcmul (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzmul (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcMul (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzMul (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSDIV (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDDIV (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsdiv (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vddiv (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsDiv (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdDiv (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSDIV (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDDIV (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsdiv (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmddiv (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsDiv (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdDiv (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCDIV (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZDIV (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcdiv (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzdiv (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcDiv (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzDiv (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCDIV (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZDIV (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcdiv (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzdiv (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcDiv (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzDiv (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSPOW (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDPOW (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vspow (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdpow (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsPow (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdPow (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSPOW (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDPOW (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmspow (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdpow (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsPow (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdPow (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VCPOW (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZPOW (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcpow (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzpow (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcPow (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzPow (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCPOW (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZPOW (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcpow (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzpow (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcPow (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzPow (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSPOW3O2 (const int *n, const float a[], float r[]); extern void __cdecl VDPOW3O2 (const int *n, const double a[], double r[]); extern void __cdecl vspow3o2 (const int *n, const float a[], float r[]); extern void __cdecl vdpow3o2 (const int *n, const double a[], double r[]); extern void __cdecl vsPow3o2 (const int n, const float a[], float r[]); extern void __cdecl vdPow3o2 (const int n, const double a[], double r[]); extern void __cdecl VMSPOW3O2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDPOW3O2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmspow3o2 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdpow3o2 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsPow3o2 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdPow3o2 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSPOW2O3 (const int *n, const float a[], float r[]); extern void __cdecl VDPOW2O3 (const int *n, const double a[], double r[]); extern void __cdecl vspow2o3 (const int *n, const float a[], float r[]); extern void __cdecl vdpow2o3 (const int *n, const double a[], double r[]); extern void __cdecl vsPow2o3 (const int n, const float a[], float r[]); extern void __cdecl vdPow2o3 (const int n, const double a[], double r[]); extern void __cdecl VMSPOW2O3 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDPOW2O3 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmspow2o3 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdpow2o3 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsPow2o3 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdPow2o3 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSPOWX (const int *n, const float a[], const float *b, float r[]); extern void __cdecl VDPOWX (const int *n, const double a[], const double *b, double r[]); extern void __cdecl vspowx (const int *n, const float a[], const float *b, float r[]); extern void __cdecl vdpowx (const int *n, const double a[], const double *b, double r[]); extern void __cdecl vsPowx (const int n, const float a[], const float b, float r[]); extern void __cdecl vdPowx (const int n, const double a[], const double b, double r[]); extern void __cdecl VMSPOWX (const int *n, const float a[], const float *b, float r[], long long int *mode); extern void __cdecl VMDPOWX (const int *n, const double a[], const double *b, double r[], long long int *mode); extern void __cdecl vmspowx (const int *n, const float a[], const float *b, float r[], long long int *mode); extern void __cdecl vmdpowx (const int *n, const double a[], const double *b, double r[], long long int *mode); extern void __cdecl vmsPowx (const int n, const float a[], const float b, float r[], long long int mode); extern void __cdecl vmdPowx (const int n, const double a[], const double b, double r[], long long int mode); extern void __cdecl VCPOWX (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[]); extern void __cdecl VZPOWX (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[]); extern void __cdecl vcpowx (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[]); extern void __cdecl vzpowx (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[]); extern void __cdecl vcPowx (const int n, const MKL_Complex8 a[], const MKL_Complex8 b, MKL_Complex8 r[]); extern void __cdecl vzPowx (const int n, const MKL_Complex16 a[], const MKL_Complex16 b, MKL_Complex16 r[]); extern void __cdecl VMCPOWX (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZPOWX (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcpowx (const int *n, const MKL_Complex8 a[], const MKL_Complex8 *b, MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzpowx (const int *n, const MKL_Complex16 a[], const MKL_Complex16 *b, MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcPowx (const int n, const MKL_Complex8 a[], const MKL_Complex8 b, MKL_Complex8 r[], long long int mode); extern void __cdecl vmzPowx (const int n, const MKL_Complex16 a[], const MKL_Complex16 b, MKL_Complex16 r[], long long int mode); extern void __cdecl VSPOWR (const int *n, const float a[], const float b[], float r[]); extern void __cdecl VDPOWR (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vspowr (const int *n, const float a[], const float b[], float r[]); extern void __cdecl vdpowr (const int *n, const double a[], const double b[], double r[]); extern void __cdecl vsPowr (const int n, const float a[], const float b[], float r[]); extern void __cdecl vdPowr (const int n, const double a[], const double b[], double r[]); extern void __cdecl VMSPOWR (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl VMDPOWR (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmspowr (const int *n, const float a[], const float b[], float r[], long long int *mode); extern void __cdecl vmdpowr (const int *n, const double a[], const double b[], double r[], long long int *mode); extern void __cdecl vmsPowr (const int n, const float a[], const float b[], float r[], long long int mode); extern void __cdecl vmdPowr (const int n, const double a[], const double b[], double r[], long long int mode); extern void __cdecl VSSINCOS (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDSINCOS (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vssincos (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdsincos (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsSinCos (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdSinCos (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSSINCOS (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDSINCOS (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmssincos (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdsincos (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsSinCos (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdSinCos (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSLINEARFRAC (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[]); extern void __cdecl VDLINEARFRAC (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[]); extern void __cdecl vslinearfrac (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[]); extern void __cdecl vdlinearfrac (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[]); extern void __cdecl vsLinearFrac (const int n, const float a[], const float b[], const float scalea, const float shifta, const float scaleb, const float shiftb, float r[]); extern void __cdecl vdLinearFrac (const int n, const double a[], const double b[], const double scalea, const double shifta, const double scaleb, const double shiftb, double r[]); extern void __cdecl VMSLINEARFRAC (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[], long long int *mode); extern void __cdecl VMDLINEARFRAC (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[], long long int *mode); extern void __cdecl vmslinearfrac (const int *n, const float a[], const float b[], const float *scalea, const float *shifta, const float *scaleb, const float *shiftb, float r[], long long int *mode); extern void __cdecl vmdlinearfrac (const int *n, const double a[], const double b[], const double *scalea, const double *shifta, const double *scaleb, const double *shiftb, double r[], long long int *mode); extern void __cdecl vmsLinearFrac (const int n, const float a[], const float b[], const float scalea, const float shifta, const float scaleb, const float shiftb, float r[], long long int mode); extern void __cdecl vmdLinearFrac (const int n, const double a[], const double b[], const double scalea, const double shifta, const double scaleb, const double shiftb, double r[], long long int mode); extern void __cdecl VSCEIL (const int *n, const float a[], float r[]); extern void __cdecl VDCEIL (const int *n, const double a[], double r[]); extern void __cdecl vsceil (const int *n, const float a[], float r[]); extern void __cdecl vdceil (const int *n, const double a[], double r[]); extern void __cdecl vsCeil (const int n, const float a[], float r[]); extern void __cdecl vdCeil (const int n, const double a[], double r[]); extern void __cdecl VMSCEIL (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDCEIL (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsceil (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdceil (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsCeil (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdCeil (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSFLOOR (const int *n, const float a[], float r[]); extern void __cdecl VDFLOOR (const int *n, const double a[], double r[]); extern void __cdecl vsfloor (const int *n, const float a[], float r[]); extern void __cdecl vdfloor (const int *n, const double a[], double r[]); extern void __cdecl vsFloor (const int n, const float a[], float r[]); extern void __cdecl vdFloor (const int n, const double a[], double r[]); extern void __cdecl VMSFLOOR (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDFLOOR (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsfloor (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdfloor (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsFloor (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdFloor (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSFRAC (const int *n, const float a[], float r[]); extern void __cdecl VDFRAC (const int *n, const double a[], double r[]); extern void __cdecl vsfrac (const int *n, const float a[], float r[]); extern void __cdecl vdfrac (const int *n, const double a[], double r[]); extern void __cdecl vsFrac (const int n, const float a[], float r[]); extern void __cdecl vdFrac (const int n, const double a[], double r[]); extern void __cdecl VMSFRAC (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDFRAC (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsfrac (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdfrac (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsFrac (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdFrac (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSMODF (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDMODF (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsmodf (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdmodf (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsModf (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdModf (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSMODF (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDMODF (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsmodf (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdmodf (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsModf (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdModf (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFMOD (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFMOD (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfmod (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfmod (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFmod (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFmod (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFMOD (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFMOD (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfmod (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfmod (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFmod (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFmod (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSREMAINDER (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDREMAINDER (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsremainder (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdremainder (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsRemainder (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdRemainder (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSREMAINDER (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDREMAINDER (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsremainder (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdremainder (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsRemainder (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdRemainder (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSNEXTAFTER (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDNEXTAFTER (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsnextafter (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdnextafter (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsNextAfter (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdNextAfter (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSNEXTAFTER (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDNEXTAFTER (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsnextafter (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdnextafter (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsNextAfter (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdNextAfter (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSCOPYSIGN (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDCOPYSIGN (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vscopysign (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdcopysign (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsCopySign (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdCopySign (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSCOPYSIGN (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDCOPYSIGN (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmscopysign (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdcopysign (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsCopySign (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdCopySign (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFDIM (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFDIM (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfdim (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfdim (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFdim (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFdim (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFDIM (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFDIM (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfdim (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfdim (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFdim (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFdim (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFMAX (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFMAX (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfmax (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfmax (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFmax (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFmax (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFMAX (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFMAX (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfmax (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfmax (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFmax (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFmax (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSFMIN (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDFMIN (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsfmin (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdfmin (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsFmin (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdFmin (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSFMIN (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDFMIN (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsfmin (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdfmin (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsFmin (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdFmin (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSMAXMAG (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDMAXMAG (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsmaxmag (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdmaxmag (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsMaxMag (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdMaxMag (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSMAXMAG (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDMAXMAG (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsmaxmag (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdmaxmag (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsMaxMag (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdMaxMag (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSMINMAG (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl VDMINMAG (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsminmag (const int *n, const float a[], float r1[], float r2[]); extern void __cdecl vdminmag (const int *n, const double a[], double r1[], double r2[]); extern void __cdecl vsMinMag (const int n, const float a[], float r1[], float r2[]); extern void __cdecl vdMinMag (const int n, const double a[], double r1[], double r2[]); extern void __cdecl VMSMINMAG (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl VMDMINMAG (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsminmag (const int *n, const float a[], float r1[], float r2[], long long int *mode); extern void __cdecl vmdminmag (const int *n, const double a[], double r1[], double r2[], long long int *mode); extern void __cdecl vmsMinMag (const int n, const float a[], float r1[], float r2[], long long int mode); extern void __cdecl vmdMinMag (const int n, const double a[], double r1[], double r2[], long long int mode); extern void __cdecl VSNEARBYINT (const int *n, const float a[], float r[]); extern void __cdecl VDNEARBYINT (const int *n, const double a[], double r[]); extern void __cdecl vsnearbyint (const int *n, const float a[], float r[]); extern void __cdecl vdnearbyint (const int *n, const double a[], double r[]); extern void __cdecl vsNearbyInt (const int n, const float a[], float r[]); extern void __cdecl vdNearbyInt (const int n, const double a[], double r[]); extern void __cdecl VMSNEARBYINT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDNEARBYINT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsnearbyint (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdnearbyint (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsNearbyInt (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdNearbyInt (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSRINT (const int *n, const float a[], float r[]); extern void __cdecl VDRINT (const int *n, const double a[], double r[]); extern void __cdecl vsrint (const int *n, const float a[], float r[]); extern void __cdecl vdrint (const int *n, const double a[], double r[]); extern void __cdecl vsRint (const int n, const float a[], float r[]); extern void __cdecl vdRint (const int n, const double a[], double r[]); extern void __cdecl VMSRINT (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDRINT (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsrint (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdrint (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsRint (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdRint (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSROUND (const int *n, const float a[], float r[]); extern void __cdecl VDROUND (const int *n, const double a[], double r[]); extern void __cdecl vsround (const int *n, const float a[], float r[]); extern void __cdecl vdround (const int *n, const double a[], double r[]); extern void __cdecl vsRound (const int n, const float a[], float r[]); extern void __cdecl vdRound (const int n, const double a[], double r[]); extern void __cdecl VMSROUND (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDROUND (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsround (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdround (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsRound (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdRound (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSTRUNC (const int *n, const float a[], float r[]); extern void __cdecl VDTRUNC (const int *n, const double a[], double r[]); extern void __cdecl vstrunc (const int *n, const float a[], float r[]); extern void __cdecl vdtrunc (const int *n, const double a[], double r[]); extern void __cdecl vsTrunc (const int n, const float a[], float r[]); extern void __cdecl vdTrunc (const int n, const double a[], double r[]); extern void __cdecl VMSTRUNC (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDTRUNC (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmstrunc (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdtrunc (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsTrunc (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdTrunc (const int n, const double a[], double r[], long long int mode); extern void __cdecl VCCONJ (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl VZCONJ (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcconj (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzconj (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl vcConj (const int n, const MKL_Complex8 a[], MKL_Complex8 r[]); extern void __cdecl vzConj (const int n, const MKL_Complex16 a[], MKL_Complex16 r[]); extern void __cdecl VMCCONJ (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCONJ (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcconj (const int *n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzconj (const int *n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcConj (const int n, const MKL_Complex8 a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzConj (const int n, const MKL_Complex16 a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VCMULBYCONJ (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl VZMULBYCONJ (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcmulbyconj (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzmulbyconj (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl vcMulByConj (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[]); extern void __cdecl vzMulByConj (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[]); extern void __cdecl VMCMULBYCONJ (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZMULBYCONJ (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcmulbyconj (const int *n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzmulbyconj (const int *n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcMulByConj (const int n, const MKL_Complex8 a[], const MKL_Complex8 b[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzMulByConj (const int n, const MKL_Complex16 a[], const MKL_Complex16 b[], MKL_Complex16 r[], long long int mode); extern void __cdecl VCCIS (const int *n, const float a[], MKL_Complex8 r[]); extern void __cdecl VZCIS (const int *n, const double a[], MKL_Complex16 r[]); extern void __cdecl vccis (const int *n, const float a[], MKL_Complex8 r[]); extern void __cdecl vzcis (const int *n, const double a[], MKL_Complex16 r[]); extern void __cdecl vcCIS (const int n, const float a[], MKL_Complex8 r[]); extern void __cdecl vzCIS (const int n, const double a[], MKL_Complex16 r[]); extern void __cdecl VMCCIS (const int *n, const float a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl VMZCIS (const int *n, const double a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmccis (const int *n, const float a[], MKL_Complex8 r[], long long int *mode); extern void __cdecl vmzcis (const int *n, const double a[], MKL_Complex16 r[], long long int *mode); extern void __cdecl vmcCIS (const int n, const float a[], MKL_Complex8 r[], long long int mode); extern void __cdecl vmzCIS (const int n, const double a[], MKL_Complex16 r[], long long int mode); extern void __cdecl VSEXPINT1 (const int *n, const float a[], float r[]); extern void __cdecl VDEXPINT1 (const int *n, const double a[], double r[]); extern void __cdecl vsexpint1 (const int *n, const float a[], float r[]); extern void __cdecl vdexpint1 (const int *n, const double a[], double r[]); extern void __cdecl vsExpInt1 (const int n, const float a[], float r[]); extern void __cdecl vdExpInt1 (const int n, const double a[], double r[]); extern void __cdecl VMSEXPINT1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl VMDEXPINT1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsexpint1 (const int *n, const float a[], float r[], long long int *mode); extern void __cdecl vmdexpint1 (const int *n, const double a[], double r[], long long int *mode); extern void __cdecl vmsExpInt1 (const int n, const float a[], float r[], long long int mode); extern void __cdecl vmdExpInt1 (const int n, const double a[], double r[], long long int mode); extern void __cdecl VSPACKI (const int *n, const float a[], const int * incra, float y[]); extern void __cdecl VDPACKI (const int *n, const double a[], const int * incra, double y[]); extern void __cdecl vspacki (const int *n, const float a[], const int * incra, float y[]); extern void __cdecl vdpacki (const int *n, const double a[], const int * incra, double y[]); extern void __cdecl vsPackI (const int n, const float a[], const int incra, float y[]); extern void __cdecl vdPackI (const int n, const double a[], const int incra, double y[]); extern void __cdecl VCPACKI (const int *n, const MKL_Complex8 a[], const int * incra, MKL_Complex8 y[]); extern void __cdecl VZPACKI (const int *n, const MKL_Complex16 a[], const int * incra, MKL_Complex16 y[]); extern void __cdecl vcpacki (const int *n, const MKL_Complex8 a[], const int * incra, MKL_Complex8 y[]); extern void __cdecl vzpacki (const int *n, const MKL_Complex16 a[], const int * incra, MKL_Complex16 y[]); extern void __cdecl vcPackI (const int n, const MKL_Complex8 a[], const int incra, MKL_Complex8 y[]); extern void __cdecl vzPackI (const int n, const MKL_Complex16 a[], const int incra, MKL_Complex16 y[]); extern void __cdecl VSPACKV (const int *n, const float a[], const int ia[], float y[]); extern void __cdecl VDPACKV (const int *n, const double a[], const int ia[], double y[]); extern void __cdecl vspackv (const int *n, const float a[], const int ia[], float y[]); extern void __cdecl vdpackv (const int *n, const double a[], const int ia[], double y[]); extern void __cdecl vsPackV (const int n, const float a[], const int ia[], float y[]); extern void __cdecl vdPackV (const int n, const double a[], const int ia[], double y[]); extern void __cdecl VCPACKV (const int *n, const MKL_Complex8 a[], const int ia[], MKL_Complex8 y[]); extern void __cdecl VZPACKV (const int *n, const MKL_Complex16 a[], const int ia[], MKL_Complex16 y[]); extern void __cdecl vcpackv (const int *n, const MKL_Complex8 a[], const int ia[], MKL_Complex8 y[]); extern void __cdecl vzpackv (const int *n, const MKL_Complex16 a[], const int ia[], MKL_Complex16 y[]); extern void __cdecl vcPackV (const int n, const MKL_Complex8 a[], const int ia[], MKL_Complex8 y[]); extern void __cdecl vzPackV (const int n, const MKL_Complex16 a[], const int ia[], MKL_Complex16 y[]); extern void __cdecl VSPACKM (const int *n, const float a[], const int ma[], float y[]); extern void __cdecl VDPACKM (const int *n, const double a[], const int ma[], double y[]); extern void __cdecl vspackm (const int *n, const float a[], const int ma[], float y[]); extern void __cdecl vdpackm (const int *n, const double a[], const int ma[], double y[]); extern void __cdecl vsPackM (const int n, const float a[], const int ma[], float y[]); extern void __cdecl vdPackM (const int n, const double a[], const int ma[], double y[]); extern void __cdecl VCPACKM (const int *n, const MKL_Complex8 a[], const int ma[], MKL_Complex8 y[]); extern void __cdecl VZPACKM (const int *n, const MKL_Complex16 a[], const int ma[], MKL_Complex16 y[]); extern void __cdecl vcpackm (const int *n, const MKL_Complex8 a[], const int ma[], MKL_Complex8 y[]); extern void __cdecl vzpackm (const int *n, const MKL_Complex16 a[], const int ma[], MKL_Complex16 y[]); extern void __cdecl vcPackM (const int n, const MKL_Complex8 a[], const int ma[], MKL_Complex8 y[]); extern void __cdecl vzPackM (const int n, const MKL_Complex16 a[], const int ma[], MKL_Complex16 y[]); extern void __cdecl VSUNPACKI (const int *n, const float a[], float y[], const int * incry); extern void __cdecl VDUNPACKI (const int *n, const double a[], double y[], const int * incry); extern void __cdecl vsunpacki (const int *n, const float a[], float y[], const int * incry); extern void __cdecl vdunpacki (const int *n, const double a[], double y[], const int * incry); extern void __cdecl vsUnpackI (const int n, const float a[], float y[], const int incry ); extern void __cdecl vdUnpackI (const int n, const double a[], double y[], const int incry ); extern void __cdecl VCUNPACKI (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int * incry); extern void __cdecl VZUNPACKI (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int * incry); extern void __cdecl vcunpacki (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int * incry); extern void __cdecl vzunpacki (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int * incry); extern void __cdecl vcUnpackI (const int n, const MKL_Complex8 a[], MKL_Complex8 y[], const int incry ); extern void __cdecl vzUnpackI (const int n, const MKL_Complex16 a[], MKL_Complex16 y[], const int incry ); extern void __cdecl VSUNPACKV (const int *n, const float a[], float y[], const int iy[] ); extern void __cdecl VDUNPACKV (const int *n, const double a[], double y[], const int iy[] ); extern void __cdecl vsunpackv (const int *n, const float a[], float y[], const int iy[] ); extern void __cdecl vdunpackv (const int *n, const double a[], double y[], const int iy[] ); extern void __cdecl vsUnpackV (const int n, const float a[], float y[], const int iy[] ); extern void __cdecl vdUnpackV (const int n, const double a[], double y[], const int iy[] ); extern void __cdecl VCUNPACKV (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int iy[]); extern void __cdecl VZUNPACKV (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int iy[]); extern void __cdecl vcunpackv (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int iy[]); extern void __cdecl vzunpackv (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int iy[]); extern void __cdecl vcUnpackV (const int n, const MKL_Complex8 a[], MKL_Complex8 y[], const int iy[]); extern void __cdecl vzUnpackV (const int n, const MKL_Complex16 a[], MKL_Complex16 y[], const int iy[]); extern void __cdecl VSUNPACKM (const int *n, const float a[], float y[], const int my[] ); extern void __cdecl VDUNPACKM (const int *n, const double a[], double y[], const int my[] ); extern void __cdecl vsunpackm (const int *n, const float a[], float y[], const int my[] ); extern void __cdecl vdunpackm (const int *n, const double a[], double y[], const int my[] ); extern void __cdecl vsUnpackM (const int n, const float a[], float y[], const int my[] ); extern void __cdecl vdUnpackM (const int n, const double a[], double y[], const int my[] ); extern void __cdecl VCUNPACKM (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int my[]); extern void __cdecl VZUNPACKM (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int my[]); extern void __cdecl vcunpackm (const int *n, const MKL_Complex8 a[], MKL_Complex8 y[], const int my[]); extern void __cdecl vzunpackm (const int *n, const MKL_Complex16 a[], MKL_Complex16 y[], const int my[]); extern void __cdecl vcUnpackM (const int n, const MKL_Complex8 a[], MKL_Complex8 y[], const int my[]); extern void __cdecl vzUnpackM (const int n, const MKL_Complex16 a[], MKL_Complex16 y[], const int my[]); extern int __cdecl VMLSETERRSTATUS (const int * status); extern int __cdecl vmlseterrstatus (const int * status); extern int __cdecl vmlSetErrStatus (const int status); extern int __cdecl VMLGETERRSTATUS (void); extern int __cdecl vmlgeterrstatus (void); extern int __cdecl vmlGetErrStatus (void); extern int __cdecl VMLCLEARERRSTATUS (void); extern int __cdecl vmlclearerrstatus (void); extern int __cdecl vmlClearErrStatus (void); extern VMLErrorCallBack __cdecl VMLSETERRORCALLBACK (const VMLErrorCallBack func); extern VMLErrorCallBack __cdecl vmlseterrorcallback (const VMLErrorCallBack func); extern VMLErrorCallBack __cdecl vmlSetErrorCallBack (const VMLErrorCallBack func); extern VMLErrorCallBack __cdecl VMLGETERRORCALLBACK (void); extern VMLErrorCallBack __cdecl vmlgeterrorcallback (void); extern VMLErrorCallBack __cdecl vmlGetErrorCallBack (void); extern VMLErrorCallBack __cdecl VMLCLEARERRORCALLBACK (void); extern VMLErrorCallBack __cdecl vmlclearerrorcallback (void); extern VMLErrorCallBack __cdecl vmlClearErrorCallBack (void); extern unsigned int __cdecl VMLSETMODE (const unsigned int *newmode); extern unsigned int __cdecl vmlsetmode (const unsigned int *newmode); extern unsigned int __cdecl vmlSetMode (const unsigned int newmode); extern unsigned int __cdecl VMLGETMODE (void); extern unsigned int __cdecl vmlgetmode (void); extern unsigned int __cdecl vmlGetMode (void); extern void __cdecl MKLFREETLS (const unsigned int *fdwReason); extern void __cdecl mklfreetls (const unsigned int *fdwReason); extern void __cdecl MKLFreeTls (const unsigned int fdwReason); #line 33 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vml.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 45 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 64 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 120 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 221 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 238 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 253 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 291 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 366 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 1031 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 1075 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_defines.h" #line 30 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_functions.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_types.h" typedef void* VSLStreamStatePtr; typedef void* VSLConvTaskPtr; typedef void* VSLCorrTaskPtr; typedef void* VSLSSTaskPtr; typedef int (*InitStreamPtr)( int method, VSLStreamStatePtr stream, int n, const unsigned int params[] ); typedef int (*sBRngPtr)( VSLStreamStatePtr stream, int n, float r[], float a, float b ); typedef int (*dBRngPtr)( VSLStreamStatePtr stream, int n, double r[], double a, double b ); typedef int (*iBRngPtr)( VSLStreamStatePtr stream, int n, unsigned int r[] ); typedef int (*iUpdateFuncPtr)( VSLStreamStatePtr stream, int* n, unsigned int ibuf[], int* nmin, int* nmax, int* idx ); typedef int (*dUpdateFuncPtr)( VSLStreamStatePtr stream, int* n, double dbuf[], int* nmin, int* nmax, int* idx ); typedef int (*sUpdateFuncPtr)( VSLStreamStatePtr stream, int* n, float sbuf[], int* nmin, int* nmax, int* idx ); typedef struct _VSLBRngProperties { int StreamStateSize; int NSeeds; int IncludesZero; int WordSize; int NBits; InitStreamPtr InitStream; sBRngPtr sBRng; dBRngPtr dBRng; iBRngPtr iBRng; } VSLBRngProperties; #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_functions.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl_functions.h" extern int __cdecl vdRngCauchy (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGCAUCHY (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrngcauchy (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngCauchy (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGCAUCHY (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrngcauchy (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngUniform (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGUNIFORM (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnguniform (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngUniform (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGUNIFORM (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnguniform (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngGaussian (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGGAUSSIAN (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnggaussian (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngGaussian (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGGAUSSIAN (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnggaussian (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngGaussianMV (const int , VSLStreamStatePtr , const int , double [], const int , const int , const double *, const double *); extern int __cdecl VDRNGGAUSSIANMV (const int *, VSLStreamStatePtr *, const int *, double [], const int *, const int *, const double *, const double *); extern int __cdecl vdrnggaussianmv (const int *, VSLStreamStatePtr *, const int *, double [], const int *, const int *, const double *, const double *); extern int __cdecl vsRngGaussianMV (const int , VSLStreamStatePtr , const int , float [], const int , const int , const float *, const float * ); extern int __cdecl VSRNGGAUSSIANMV (const int *, VSLStreamStatePtr *, const int *, float [], const int *, const int *, const float *, const float * ); extern int __cdecl vsrnggaussianmv (const int *, VSLStreamStatePtr *, const int *, float [], const int *, const int *, const float *, const float * ); extern int __cdecl vdRngExponential (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGEXPONENTIAL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrngexponential (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngExponential (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGEXPONENTIAL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrngexponential (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngLaplace (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGLAPLACE (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnglaplace (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngLaplace (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGLAPLACE (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnglaplace (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngWeibull (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double ); extern int __cdecl VDRNGWEIBULL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vdrngweibull (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vsRngWeibull (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float ); extern int __cdecl VSRNGWEIBULL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vsrngweibull (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vdRngRayleigh (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGRAYLEIGH (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrngrayleigh (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngRayleigh (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGRAYLEIGH (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrngrayleigh (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngLognormal (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double , const double ); extern int __cdecl VDRNGLOGNORMAL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vdrnglognormal (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vsRngLognormal (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float , const float ); extern int __cdecl VSRNGLOGNORMAL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl vsrnglognormal (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl vdRngGumbel (const int , VSLStreamStatePtr , const int , double [], const double , const double ); extern int __cdecl VDRNGGUMBEL (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vdrnggumbel (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *); extern int __cdecl vsRngGumbel (const int , VSLStreamStatePtr , const int , float [], const float , const float ); extern int __cdecl VSRNGGUMBEL (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vsrnggumbel (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float * ); extern int __cdecl vdRngGamma (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double ); extern int __cdecl VDRNGGAMMA (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vdrnggamma (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *); extern int __cdecl vsRngGamma (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float ); extern int __cdecl VSRNGGAMMA (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vsrnggamma (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float * ); extern int __cdecl vdRngBeta (const int , VSLStreamStatePtr , const int , double [], const double , const double , const double , const double ); extern int __cdecl VDRNGBETA (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vdrngbeta (const int *, VSLStreamStatePtr *, const int *, double [], const double *, const double *, const double *, const double *); extern int __cdecl vsRngBeta (const int , VSLStreamStatePtr , const int , float [], const float , const float , const float , const float ); extern int __cdecl VSRNGBETA (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl vsrngbeta (const int *, VSLStreamStatePtr *, const int *, float [], const float *, const float *, const float *, const float * ); extern int __cdecl viRngBernoulli (const int , VSLStreamStatePtr , const int , int [], const double ); extern int __cdecl VIRNGBERNOULLI (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl virngbernoulli (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl viRngUniform (const int , VSLStreamStatePtr , const int , int [], const int , const int ); extern int __cdecl VIRNGUNIFORM (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *); extern int __cdecl virnguniform (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *); extern int __cdecl viRngUniformBits (const int , VSLStreamStatePtr , const int , unsigned int []); extern int __cdecl VIRNGUNIFORMBITS (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl virnguniformbits (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl viRngUniformBits32 (const int , VSLStreamStatePtr , const int , unsigned int []); extern int __cdecl VIRNGUNIFORMBITS32 (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl virnguniformbits32 (const int *, VSLStreamStatePtr *, const int *, unsigned int []); extern int __cdecl viRngUniformBits64 (const int , VSLStreamStatePtr , const int , unsigned long long int []); extern int __cdecl VIRNGUNIFORMBITS64 (const int *, VSLStreamStatePtr *, const int *, unsigned long long int []); extern int __cdecl virnguniformbits64 (const int *, VSLStreamStatePtr *, const int *, unsigned long long int []); extern int __cdecl viRngGeometric (const int , VSLStreamStatePtr , const int , int [], const double ); extern int __cdecl VIRNGGEOMETRIC (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl virnggeometric (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl viRngBinomial (const int , VSLStreamStatePtr , const int , int [], const int , const double ); extern int __cdecl VIRNGBINOMIAL (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const double *); extern int __cdecl virngbinomial (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const double *); extern int __cdecl viRngHypergeometric (const int , VSLStreamStatePtr , const int , int [], const int , const int , const int ); extern int __cdecl VIRNGHYPERGEOMETRIC (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *, const int *); extern int __cdecl virnghypergeometric (const int *, VSLStreamStatePtr *, const int *, int [], const int *, const int *, const int *); extern int __cdecl viRngNegbinomial (const int , VSLStreamStatePtr , const int , int [], const double , const double ); extern int __cdecl viRngNegBinomial (const int , VSLStreamStatePtr , const int , int [], const double , const double ); extern int __cdecl VIRNGNEGBINOMIAL (const int *, VSLStreamStatePtr *, const int *, int [], const double *, const double *); extern int __cdecl virngnegbinomial (const int *, VSLStreamStatePtr *, const int *, int [], const double *, const double *); extern int __cdecl viRngPoisson (const int , VSLStreamStatePtr , const int , int [], const double ); extern int __cdecl VIRNGPOISSON (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl virngpoisson (const int *, VSLStreamStatePtr *, const int *, int [], const double *); extern int __cdecl viRngPoissonV (const int , VSLStreamStatePtr , const int , int [], const double []); extern int __cdecl VIRNGPOISSONV (const int *, VSLStreamStatePtr *, const int *, int [], const double []); extern int __cdecl virngpoissonv (const int *, VSLStreamStatePtr *, const int *, int [], const double []); extern int __cdecl vslNewStream (VSLStreamStatePtr* , const int , const unsigned int ); extern int __cdecl vslnewstream (VSLStreamStatePtr* , const int *, const unsigned int *); extern int __cdecl VSLNEWSTREAM (VSLStreamStatePtr* , const int *, const unsigned int *); extern int __cdecl vslNewStreamEx (VSLStreamStatePtr* , const int , const int , const unsigned int[]); extern int __cdecl vslnewstreamex (VSLStreamStatePtr* , const int *, const int *, const unsigned int[]); extern int __cdecl VSLNEWSTREAMEX (VSLStreamStatePtr* , const int *, const int *, const unsigned int[]); extern int __cdecl vsliNewAbstractStream (VSLStreamStatePtr* , const int , const unsigned int[], const iUpdateFuncPtr); extern int __cdecl vslinewabstractstream (VSLStreamStatePtr* , const int *, const unsigned int[], const iUpdateFuncPtr); extern int __cdecl VSLINEWABSTRACTSTREAM (VSLStreamStatePtr* , const int *, const unsigned int[], const iUpdateFuncPtr); extern int __cdecl vsldNewAbstractStream (VSLStreamStatePtr* , const int , const double[], const double , const double , const dUpdateFuncPtr); extern int __cdecl vsldnewabstractstream (VSLStreamStatePtr* , const int *, const double[], const double *, const double *, const dUpdateFuncPtr); extern int __cdecl VSLDNEWABSTRACTSTREAM (VSLStreamStatePtr* , const int *, const double[], const double *, const double *, const dUpdateFuncPtr); extern int __cdecl vslsNewAbstractStream (VSLStreamStatePtr* , const int , const float[], const float , const float , const sUpdateFuncPtr); extern int __cdecl vslsnewabstractstream (VSLStreamStatePtr* , const int *, const float[], const float *, const float *, const sUpdateFuncPtr); extern int __cdecl VSLSNEWABSTRACTSTREAM (VSLStreamStatePtr* , const int *, const float[], const float *, const float *, const sUpdateFuncPtr); extern int __cdecl vslDeleteStream (VSLStreamStatePtr*); extern int __cdecl vsldeletestream (VSLStreamStatePtr*); extern int __cdecl VSLDELETESTREAM (VSLStreamStatePtr*); extern int __cdecl vslCopyStream (VSLStreamStatePtr*, const VSLStreamStatePtr); extern int __cdecl vslcopystream (VSLStreamStatePtr*, const VSLStreamStatePtr); extern int __cdecl VSLCOPYSTREAM (VSLStreamStatePtr*, const VSLStreamStatePtr); extern int __cdecl vslCopyStreamState (VSLStreamStatePtr , const VSLStreamStatePtr ); extern int __cdecl vslcopystreamstate (VSLStreamStatePtr *, const VSLStreamStatePtr *); extern int __cdecl VSLCOPYSTREAMSTATE (VSLStreamStatePtr *, const VSLStreamStatePtr *); extern int __cdecl vslLeapfrogStream (VSLStreamStatePtr , const int , const int ); extern int __cdecl vslleapfrogstream (VSLStreamStatePtr *, const int *, const int *); extern int __cdecl VSLLEAPFROGSTREAM (VSLStreamStatePtr *, const int *, const int *); extern int __cdecl vslSkipAheadStream (VSLStreamStatePtr , const __int64 ); extern int __cdecl vslskipaheadstream (VSLStreamStatePtr *, const __int64 *); extern int __cdecl VSLSKIPAHEADSTREAM (VSLStreamStatePtr *, const __int64 *); extern int __cdecl vslGetStreamStateBrng (const VSLStreamStatePtr ); extern int __cdecl vslgetstreamstatebrng (const VSLStreamStatePtr *); extern int __cdecl VSLGETSTREAMSTATEBRNG (const VSLStreamStatePtr *); extern int __cdecl vslGetNumRegBrngs (void); extern int __cdecl vslgetnumregbrngs (void); extern int __cdecl VSLGETNUMREGBRNGS (void); extern int __cdecl vslRegisterBrng (const VSLBRngProperties* ); extern int __cdecl vslregisterbrng (const VSLBRngProperties* ); extern int __cdecl VSLREGISTERBRNG (const VSLBRngProperties* ); extern int __cdecl vslGetBrngProperties (const int , VSLBRngProperties* ); extern int __cdecl vslgetbrngproperties (const int *, VSLBRngProperties* ); extern int __cdecl VSLGETBRNGPROPERTIES (const int *, VSLBRngProperties* ); extern int __cdecl vslSaveStreamF (const VSLStreamStatePtr , const char* ); extern int __cdecl vslsavestreamf (const VSLStreamStatePtr *, const char* , const int ); extern int __cdecl VSLSAVESTREAMF (const VSLStreamStatePtr *, const char* , const int ); extern int __cdecl vslLoadStreamF (VSLStreamStatePtr *, const char* ); extern int __cdecl vslloadstreamf (VSLStreamStatePtr *, const char* , const int ); extern int __cdecl VSLLOADSTREAMF (VSLStreamStatePtr *, const char* , const int ); extern int __cdecl vslSaveStreamM (const VSLStreamStatePtr , char* ); extern int __cdecl vslsavestreamm (const VSLStreamStatePtr *, char* ); extern int __cdecl VSLSAVESTREAMM (const VSLStreamStatePtr *, char* ); extern int __cdecl vslLoadStreamM (VSLStreamStatePtr *, const char* ); extern int __cdecl vslloadstreamm (VSLStreamStatePtr *, const char* ); extern int __cdecl VSLLOADSTREAMM (VSLStreamStatePtr *, const char* ); extern int __cdecl vslGetStreamSize (const VSLStreamStatePtr); extern int __cdecl vslgetstreamsize (const VSLStreamStatePtr); extern int __cdecl VSLGETSTREAMSIZE (const VSLStreamStatePtr); extern int __cdecl vsldConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vsldconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLDCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslsConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslsconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLSCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslzConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslzconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLZCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslcConvNewTask (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslcconvnewtask (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLCCONVNEWTASK (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vsldCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vsldcorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLDCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslsCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslscorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLSCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslzCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslzcorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLZCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vslcCorrNewTask (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int []); extern int __cdecl vslccorrnewtask (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl VSLCCORRNEWTASK (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int []); extern int __cdecl vsldConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vsldconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLDCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslsConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslsconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLSCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslzConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslzconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLZCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslcConvNewTask1D (VSLConvTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslcconvnewtask1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLCCONVNEWTASK1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vsldCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vsldcorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLDCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslsCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslscorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLSCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslzCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslzcorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLZCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vslcCorrNewTask1D (VSLCorrTaskPtr* , const int , const int , const int , const int ); extern int __cdecl vslccorrnewtask1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl VSLCCORRNEWTASK1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* ); extern int __cdecl vsldConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vsldconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl VSLDCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vslsConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslsconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl VSLSCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslzConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslzconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl VSLZCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslcConvNewTaskX (VSLConvTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vslcconvnewtaskx (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl VSLCCONVNEWTASKX (VSLConvTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vsldCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vsldcorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl VSLDCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const double [], const int []); extern int __cdecl vslsCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslscorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl VSLSCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const float [], const int []); extern int __cdecl vslzCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslzcorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl VSLZCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex16 [], const int []); extern int __cdecl vslcCorrNewTaskX (VSLCorrTaskPtr* , const int , const int , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vslccorrnewtaskx (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl VSLCCORRNEWTASKX (VSLCorrTaskPtr* , const int* , const int* , const int [], const int [], const int [], const MKL_Complex8 [], const int []); extern int __cdecl vsldConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const double [], const int ); extern int __cdecl vsldconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl VSLDCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl vslsConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const float [], const int ); extern int __cdecl vslsconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl VSLSCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl vslzConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const MKL_Complex16 [], const int ); extern int __cdecl vslzconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl VSLZCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl vslcConvNewTaskX1D (VSLConvTaskPtr* , const int , const int , const int , const int , const MKL_Complex8 [], const int ); extern int __cdecl vslcconvnewtaskx1d (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl VSLCCONVNEWTASKX1D (VSLConvTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl vsldCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const double [], const int ); extern int __cdecl vsldcorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl VSLDCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const double [], const int* ); extern int __cdecl vslsCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const float [], const int ); extern int __cdecl vslscorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl VSLSCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const float [], const int* ); extern int __cdecl vslzCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const MKL_Complex16 [], const int ); extern int __cdecl vslzcorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl VSLZCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex16 [], const int* ); extern int __cdecl vslcCorrNewTaskX1D (VSLCorrTaskPtr* , const int , const int , const int , const int , const MKL_Complex8 [], const int ); extern int __cdecl vslccorrnewtaskx1d (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl VSLCCORRNEWTASKX1D (VSLCorrTaskPtr* , const int* , const int* , const int* , const int* , const MKL_Complex8 [], const int* ); extern int __cdecl vslConvDeleteTask (VSLConvTaskPtr* ); extern int __cdecl vslconvdeletetask (VSLConvTaskPtr* ); extern int __cdecl VSLCONVDeleteTask (VSLConvTaskPtr* ); extern int __cdecl vslCorrDeleteTask (VSLCorrTaskPtr* ); extern int __cdecl vslcorrdeletetask (VSLCorrTaskPtr* ); extern int __cdecl VSLCORRDeleteTask (VSLCorrTaskPtr* ); extern int __cdecl vslConvCopyTask (VSLConvTaskPtr* , const VSLConvTaskPtr ); extern int __cdecl vslconvcopytask (VSLConvTaskPtr* , const VSLConvTaskPtr* ); extern int __cdecl VSLCONVCopyTask (VSLConvTaskPtr* , const VSLConvTaskPtr* ); extern int __cdecl vslCorrCopyTask (VSLCorrTaskPtr* , const VSLCorrTaskPtr ); extern int __cdecl vslcorrcopytask (VSLCorrTaskPtr* , const VSLCorrTaskPtr* ); extern int __cdecl VSLCORRCopyTask (VSLCorrTaskPtr* , const VSLCorrTaskPtr* ); extern int __cdecl vslConvSetMode (VSLConvTaskPtr , const int ); extern int __cdecl vslconvsetmode (VSLConvTaskPtr* , const int* ); extern int __cdecl VSLCONVSETMODE (VSLConvTaskPtr* , const int* ); extern int __cdecl vslCorrSetMode (VSLCorrTaskPtr , const int ); extern int __cdecl vslcorrsetmode (VSLCorrTaskPtr* , const int* ); extern int __cdecl VSLCORRSETMODE (VSLCorrTaskPtr* , const int* ); extern int __cdecl vslConvSetInternalPrecision (VSLConvTaskPtr , const int ); extern int __cdecl vslconvsetinternalprecision (VSLConvTaskPtr* , const int* ); extern int __cdecl VSLCONVSETINTERNALPRECISION (VSLConvTaskPtr* , const int* ); extern int __cdecl vslCorrSetInternalPrecision (VSLCorrTaskPtr , const int ); extern int __cdecl vslcorrsetinternalprecision (VSLCorrTaskPtr* , const int* ); extern int __cdecl VSLCORRSETINTERNALPRECISION (VSLCorrTaskPtr* , const int* ); extern int __cdecl vslConvSetStart (VSLConvTaskPtr , const int []); extern int __cdecl vslconvsetstart (VSLConvTaskPtr* , const int []); extern int __cdecl VSLCONVSETSTART (VSLConvTaskPtr* , const int []); extern int __cdecl vslCorrSetStart (VSLCorrTaskPtr , const int []); extern int __cdecl vslcorrsetstart (VSLCorrTaskPtr* , const int []); extern int __cdecl VSLCORRSETSTART (VSLCorrTaskPtr* , const int []); extern int __cdecl vslConvSetDecimation (VSLConvTaskPtr , const int []); extern int __cdecl vslconvsetdecimation (VSLConvTaskPtr* , const int []); extern int __cdecl VSLCONVSETDECIMATION (VSLConvTaskPtr* , const int []); extern int __cdecl vslCorrSetDecimation (VSLCorrTaskPtr , const int []); extern int __cdecl vslcorrsetdecimation (VSLCorrTaskPtr* , const int []); extern int __cdecl VSLCORRSETDECIMATION (VSLCorrTaskPtr* , const int []); extern int __cdecl vsldConvExec (VSLConvTaskPtr , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vsldconvexec (VSLConvTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl VSLDCONVEXEC (VSLConvTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vslsConvExec (VSLConvTaskPtr , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslsconvexec (VSLConvTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl VSLSCONVEXEC (VSLConvTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslzConvExec (VSLConvTaskPtr , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzconvexec (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCONVEXEC (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcConvExec (VSLConvTaskPtr , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslcconvexec (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCONVEXEC (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldCorrExec (VSLCorrTaskPtr , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vsldcorrexec (VSLCorrTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl VSLDCORREXEC (VSLCorrTaskPtr* , const double [], const int [], const double [], const int [], double [], const int []); extern int __cdecl vslsCorrExec (VSLCorrTaskPtr , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslscorrexec (VSLCorrTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl VSLSCORREXEC (VSLCorrTaskPtr* , const float [], const int [], const float [], const int [], float [], const int []); extern int __cdecl vslzCorrExec (VSLCorrTaskPtr , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzcorrexec (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCORREXEC (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcCorrExec (VSLCorrTaskPtr , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslccorrexec (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCORREXEC (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldConvExec1D (VSLConvTaskPtr , const double [], const int , const double [], const int , double [], const int ); extern int __cdecl vsldconvexec1d (VSLConvTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCONVEXEC1D (VSLConvTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl vslsConvExec1D (VSLConvTaskPtr , const float [], const int , const float [], const int , float [], const int ); extern int __cdecl vslsconvexec1d (VSLConvTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCONVEXEC1D (VSLConvTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl vslzConvExec1D (VSLConvTaskPtr , const MKL_Complex16 [], const int , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzconvexec1d (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCONVEXEC1D (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcConvExec1D (VSLConvTaskPtr , const MKL_Complex8 [], const int , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslcconvexec1d (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCONVEXEC1D (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldCorrExec1D (VSLCorrTaskPtr , const double [], const int , const double [], const int , double [], const int ); extern int __cdecl vsldcorrexec1d (VSLCorrTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCORREXEC1D (VSLCorrTaskPtr* , const double [], const int* , const double [], const int* , double [], const int* ); extern int __cdecl vslsCorrExec1D (VSLCorrTaskPtr , const float [], const int , const float [], const int , float [], const int ); extern int __cdecl vslscorrexec1d (VSLCorrTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCORREXEC1D (VSLCorrTaskPtr* , const float [], const int* , const float [], const int* , float [], const int* ); extern int __cdecl vslzCorrExec1D (VSLCorrTaskPtr , const MKL_Complex16 [], const int , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzcorrexec1d (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCORREXEC1D (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcCorrExec1D (VSLCorrTaskPtr , const MKL_Complex8 [], const int , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslccorrexec1d (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCORREXEC1D (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldConvExecX (VSLConvTaskPtr , const double [], const int [], double [], const int []); extern int __cdecl vsldconvexecx (VSLConvTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl VSLDCONVEXECX (VSLConvTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl vslsConvExecX (VSLConvTaskPtr , const float [], const int [], float [], const int []); extern int __cdecl vslsconvexecx (VSLConvTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl VSLSCONVEXECX (VSLConvTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl vslzConvExecX (VSLConvTaskPtr , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzconvexecx (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCONVEXECX (VSLConvTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcConvExecX (VSLConvTaskPtr , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslcconvexecx (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCONVEXECX (VSLConvTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldCorrExecX (VSLCorrTaskPtr , const double [], const int [], double [], const int []); extern int __cdecl vsldcorrexecx (VSLCorrTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl VSLDCORREXECX (VSLCorrTaskPtr* , const double [], const int [], double [], const int []); extern int __cdecl vslsCorrExecX (VSLCorrTaskPtr , const float [], const int [], float [], const int []); extern int __cdecl vslscorrexecx (VSLCorrTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl VSLSCORREXECX (VSLCorrTaskPtr* , const float [], const int [], float [], const int []); extern int __cdecl vslzCorrExecX (VSLCorrTaskPtr , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslzcorrexecx (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl VSLZCORREXECX (VSLCorrTaskPtr* , const MKL_Complex16 [], const int [], MKL_Complex16 [], const int []); extern int __cdecl vslcCorrExecX (VSLCorrTaskPtr , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vslccorrexecx (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl VSLCCORREXECX (VSLCorrTaskPtr* , const MKL_Complex8 [], const int [], MKL_Complex8 [], const int []); extern int __cdecl vsldConvExecX1D (VSLConvTaskPtr , const double [], const int , double [], const int ); extern int __cdecl vsldconvexecx1d (VSLConvTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCONVEXECX1D (VSLConvTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl vslsConvExecX1D (VSLConvTaskPtr , const float [], const int , float [], const int ); extern int __cdecl vslsconvexecx1d (VSLConvTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCONVEXECX1D (VSLConvTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl vslzConvExecX1D (VSLConvTaskPtr , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzconvexecx1d (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCONVEXECX1D (VSLConvTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcConvExecX1D (VSLConvTaskPtr , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslcconvexecx1d (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCONVEXECX1D (VSLConvTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldCorrExecX1D (VSLCorrTaskPtr , const double [], const int , double [], const int ); extern int __cdecl vsldcorrexecx1d (VSLCorrTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl VSLDCORREXECX1D (VSLCorrTaskPtr* , const double [], const int* , double [], const int* ); extern int __cdecl vslsCorrExecX1D (VSLCorrTaskPtr , const float [], const int , float [], const int ); extern int __cdecl vslscorrexecx1d (VSLCorrTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl VSLSCORREXECX1D (VSLCorrTaskPtr* , const float [], const int* , float [], const int* ); extern int __cdecl vslzCorrExecX1D (VSLCorrTaskPtr , const MKL_Complex16 [], const int , MKL_Complex16 [], const int ); extern int __cdecl vslzcorrexecx1d (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl VSLZCORREXECX1D (VSLCorrTaskPtr* , const MKL_Complex16 [], const int* , MKL_Complex16 [], const int* ); extern int __cdecl vslcCorrExecX1D (VSLCorrTaskPtr , const MKL_Complex8 [], const int , MKL_Complex8 [], const int ); extern int __cdecl vslccorrexecx1d (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl VSLCCORREXECX1D (VSLCorrTaskPtr* , const MKL_Complex8 [], const int* , MKL_Complex8 [], const int* ); extern int __cdecl vsldSSNewTask (VSLSSTaskPtr* , const int* , const int* , const int* , const double [], const double [], const int []); extern int __cdecl vsldssnewtask (VSLSSTaskPtr* , const int* , const int* , const int* , const double [], const double [], const int []); extern int __cdecl VSLDSSNEWTASK (VSLSSTaskPtr* , const int* , const int* , const int* , const double [], const double [], const int []); extern int __cdecl vslsSSNewTask (VSLSSTaskPtr* , const int* , const int* , const int* , const float [], const float [], const int []); extern int __cdecl vslsssnewtask (VSLSSTaskPtr* , const int* , const int* , const int* , const float [], const float [], const int []); extern int __cdecl VSLSSSNEWTASK (VSLSSTaskPtr* , const int* , const int* , const int* , const float [], const float [], const int []); extern int __cdecl vsldSSEditTask (VSLSSTaskPtr , const int , const double* ); extern int __cdecl vsldssedittask (VSLSSTaskPtr* , const int* , const double* ); extern int __cdecl VSLDSSEDITTASK (VSLSSTaskPtr* , const int* , const double* ); extern int __cdecl vslsSSEditTask (VSLSSTaskPtr , const int , const float* ); extern int __cdecl vslsssedittask (VSLSSTaskPtr* , const int* , const float* ); extern int __cdecl VSLSSSEDITTASK (VSLSSTaskPtr* , const int* , const float* ); extern int __cdecl vsliSSEditTask (VSLSSTaskPtr , const int , const int* ); extern int __cdecl vslissedittask (VSLSSTaskPtr* , const int* , const int* ); extern int __cdecl VSLISSEDITTASK (VSLSSTaskPtr* , const int* , const int* ); extern int __cdecl vsldSSEditMoments (VSLSSTaskPtr , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vsldsseditmoments (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl VSLDSSEDITMOMENTS (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vslsSSEditMoments (VSLSSTaskPtr , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vslssseditmoments (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl VSLSSSEDITMOMENTS (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vsldSSEditSums (VSLSSTaskPtr , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vsldsseditsums (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl VSLDSSEDITSUMS (VSLSSTaskPtr* , double* , double* , double* , double* , double* , double* , double* ); extern int __cdecl vslsSSEditSums (VSLSSTaskPtr , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vslssseditsums (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl VSLSSSEDITSUMS (VSLSSTaskPtr* , float* , float* , float* , float* , float* , float* , float* ); extern int __cdecl vsldSSEditCovCor (VSLSSTaskPtr , double* , double* , const int* , double* , const int* ); extern int __cdecl vsldsseditcovcor (VSLSSTaskPtr* , double* , double* , const int* , double* , const int* ); extern int __cdecl VSLDSSEDITCOVCOR (VSLSSTaskPtr* , double* , double* , const int* , double* , const int* ); extern int __cdecl vslsSSEditCovCor (VSLSSTaskPtr , float* , float* , const int* , float* , const int* ); extern int __cdecl vslssseditcovcor (VSLSSTaskPtr* , float* , float* , const int* , float* , const int* ); extern int __cdecl VSLSSSEDITCOVCOR (VSLSSTaskPtr* , float* , float* , const int* , float* , const int* ); extern int __cdecl vsldSSEditCP (VSLSSTaskPtr , double* , double* , double* , const int* ); extern int __cdecl vsldsseditcp (VSLSSTaskPtr* , double* , double* , double* , const int* ); extern int __cdecl VSLDSSEDITCP (VSLSSTaskPtr* , double* , double* , double* , const int* ); extern int __cdecl vslsSSEditCP (VSLSSTaskPtr , float* , float* , float* , const int* ); extern int __cdecl vslssseditcp (VSLSSTaskPtr* , float* , float* , float* , const int* ); extern int __cdecl VSLSSSEDITCP (VSLSSTaskPtr* , float* , float* , float* , const int* ); extern int __cdecl vsldSSEditPartialCovCor (VSLSSTaskPtr , const int [], const double* , const int* , const double* , const int* , double* , const int* , double* , const int* ); extern int __cdecl vsldsseditpartialcovcor (VSLSSTaskPtr* , const int [], const double* , const int* , const double* , const int* , double* , const int* , double* , const int* ); extern int __cdecl VSLDSSEDITPARTIALCOVCOR (VSLSSTaskPtr* , const int [], const double* , const int* , const double* , const int* , double* , const int* , double* , const int* ); extern int __cdecl vslsSSEditPartialCovCor (VSLSSTaskPtr , const int [], const float* , const int* , const float* , const int* , float* , const int* , float* , const int* ); extern int __cdecl vslssseditpartialcovcor (VSLSSTaskPtr* , const int [], const float* , const int* , const float* , const int* , float* , const int* , float* , const int* ); extern int __cdecl VSLSSSEDITPARTIALCOVCOR (VSLSSTaskPtr* , const int [], const float* , const int* , const float* , const int* , float* , const int* , float* , const int* ); extern int __cdecl vsldSSEditQuantiles (VSLSSTaskPtr , const int* , const double* , double* , double* , const int* ); extern int __cdecl vsldsseditquantiles (VSLSSTaskPtr* , const int* , const double* , double* , double* , const int* ); extern int __cdecl VSLDSSEDITQUANTILES (VSLSSTaskPtr* , const int* , const double* , double* , double* , const int* ); extern int __cdecl vslsSSEditQuantiles (VSLSSTaskPtr , const int* , const float* , float* , float* , const int* ); extern int __cdecl vslssseditquantiles (VSLSSTaskPtr* , const int* , const float* , float* , float* , const int* ); extern int __cdecl VSLSSSEDITQUANTILES (VSLSSTaskPtr* , const int* , const float* , float* , float* , const int* ); extern int __cdecl vsldSSEditStreamQuantiles (VSLSSTaskPtr , const int* , const double* , double* , const int* , const double* ); extern int __cdecl vsldsseditstreamquantiles (VSLSSTaskPtr* , const int* , const double* , double* , const int* , const double* ); extern int __cdecl VSLDSSEDITSTREAMQUANTILES (VSLSSTaskPtr* , const int* , const double* , double* , const int* , const double* ); extern int __cdecl vslsSSEditStreamQuantiles (VSLSSTaskPtr , const int* , const float* , float* , const int* , const float* ); extern int __cdecl vslssseditstreamquantiles (VSLSSTaskPtr* , const int* , const float* , float* , const int* , const float* ); extern int __cdecl VSLSSSEDITSTREAMQUANTILES (VSLSSTaskPtr* , const int* , const float* , float* , const int* , const float* ); extern int __cdecl vsldSSEditPooledCovariance (VSLSSTaskPtr , const int* , double* , double* , const int* , double* , double* ); extern int __cdecl vsldsseditpooledcovariance (VSLSSTaskPtr* , const int* , double* , double* , const int* , double* , double* ); extern int __cdecl VSLDSSEDITPOOLEDCOVARIANCE (VSLSSTaskPtr* , const int* , double* , double* , const int* , double* , double* ); extern int __cdecl vslsSSEditPooledCovariance (VSLSSTaskPtr , const int* , float* , float* , const int* , float* , float* ); extern int __cdecl vslssseditpooledcovariance (VSLSSTaskPtr* , const int* , float* , float* , const int* , float* , float* ); extern int __cdecl VSLSSSEDITPOOLEDCOVARIANCE (VSLSSTaskPtr* , const int* , float* , float* , const int* , float* , float* ); extern int __cdecl vsldSSEditRobustCovariance (VSLSSTaskPtr , const int* , const int* , const double* , double* , double* ); extern int __cdecl vsldsseditrobustcovariance (VSLSSTaskPtr* , const int* , const int* , const double* , double* , double* ); extern int __cdecl VSLDSSEDITROBUSTCOVARIANCE (VSLSSTaskPtr* , const int* , const int* , const double* , double* , double* ); extern int __cdecl vslsSSEditRobustCovariance (VSLSSTaskPtr , const int* , const int* , const float* , float* , float* ); extern int __cdecl vslssseditrobustcovariance (VSLSSTaskPtr* , const int* , const int* , const float* , float* , float* ); extern int __cdecl VSLSSSEDITROBUSTCOVARIANCE (VSLSSTaskPtr* , const int* , const int* , const float* , float* , float* ); extern int __cdecl vsldSSEditOutliersDetection (VSLSSTaskPtr , const int* , const double* , double* ); extern int __cdecl vsldsseditoutliersdetection (VSLSSTaskPtr* , const int* , const double* , double* ); extern int __cdecl VSLDSSEDITOUTLIERSDETECTION (VSLSSTaskPtr* , const int* , const double* , double* ); extern int __cdecl vslsSSEditOutliersDetection (VSLSSTaskPtr , const int* , const float* , float* ); extern int __cdecl vslssseditoutliersdetection (VSLSSTaskPtr* , const int* , const float* , float* ); extern int __cdecl VSLSSSEDITOUTLIERSDETECTION (VSLSSTaskPtr* , const int* , const float* , float* ); extern int __cdecl vsldSSEditMissingValues (VSLSSTaskPtr , const int* , const double* , const int* , const double* , const int* , const double* , const int* , double* , const int* , double* ); extern int __cdecl vsldsseditmissingvalues (VSLSSTaskPtr* , const int* , const double* , const int* , const double* , const int* , const double* , const int* , double* , const int* , double* ); extern int __cdecl VSLDSSEDITMISSINGVALUES (VSLSSTaskPtr* , const int* , const double* , const int* , const double* , const int* , const double* , const int* , double* , const int* , double* ); extern int __cdecl vslsSSEditMissingValues (VSLSSTaskPtr , const int* , const float* , const int* , const float* , const int* , const float* , const int* , float* , const int* , float* ); extern int __cdecl vslssseditmissingvalues (VSLSSTaskPtr* , const int* , const float* , const int* , const float* , const int* , const float* , const int* , float* , const int* , float* ); extern int __cdecl VSLSSSEDITMISSINGVALUES (VSLSSTaskPtr* , const int* , const float* , const int* , const float* , const int* , const float* , const int* , float* , const int* , float* ); extern int __cdecl vsldSSEditCorParameterization (VSLSSTaskPtr , const double* , const int* , double* , const int* ); extern int __cdecl vsldsseditcorparameterization (VSLSSTaskPtr* , const double* , const int* , double* , const int* ); extern int __cdecl VSLDSSEDITCORPARAMETERIZATION (VSLSSTaskPtr* , const double* , const int* , double* , const int* ); extern int __cdecl vslsSSEditCorParameterization (VSLSSTaskPtr , const float* , const int* , float* , const int* ); extern int __cdecl vslssseditcorparameterization (VSLSSTaskPtr* , const float* , const int* , float* , const int* ); extern int __cdecl VSLSSSEDITCORPARAMETERIZATION (VSLSSTaskPtr* , const float* , const int* , float* , const int* ); extern int __cdecl vsldSSCompute (VSLSSTaskPtr , const unsigned long long int , const int ); extern int __cdecl vsldsscompute (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl VSLDSSCOMPUTE (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl vslsSSCompute (VSLSSTaskPtr , const unsigned long long int , const int ); extern int __cdecl vslssscompute (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl VSLSSSCOMPUTE (VSLSSTaskPtr* , const unsigned long long int* , const int* ); extern int __cdecl vslSSDeleteTask (VSLSSTaskPtr* ); extern int __cdecl vslssdeletetask (VSLSSTaskPtr* ); extern int __cdecl VSLSSDELETETASK (VSLSSTaskPtr* ); #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_vsl.h" #line 51 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 73 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 91 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 130 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 157 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 172 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_defines.h" #line 30 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_functions.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_types.h" typedef void* DFTaskPtr; typedef struct _dfSearchCallBackLibraryParams{ int limit_type_flag; } dfSearchCallBackLibraryParams; typedef struct _dfInterpCallBackLibraryParams{ int reserved1; } dfInterpCallBackLibraryParams; typedef struct _dfIntegrCallBackLibraryParams{ int reserved1; } dfIntegrCallBackLibraryParams; typedef int (*dfsInterpCallBack) ( long long int* n, long long int cell[], float site[], float r[], void* user_param, dfInterpCallBackLibraryParams* library_params ); typedef int (*dfdInterpCallBack) ( long long int* n, long long int cell[], double site[], double r[], void* user_param, dfInterpCallBackLibraryParams* library_params ); typedef int (*dfsIntegrCallBack) ( long long int* n, long long int lcell[], float llim[], long long int rcell[], float rlim[], float r[], void* user_params, dfIntegrCallBackLibraryParams* library_params ); typedef int (*dfdIntegrCallBack) ( long long int* n, long long int lcell[], double llim[], long long int rcell[], double rlim[], double r[], void* user_params, dfIntegrCallBackLibraryParams* library_params ); typedef int (*dfsSearchCellsCallBack) ( long long int* n, float site[], long long int cell[], int flag[], void* user_params, dfSearchCallBackLibraryParams* library_params ); typedef int (*dfdSearchCellsCallBack) ( long long int* n, double site[], long long int cell[], int flag[], void* user_params, dfSearchCallBackLibraryParams* library_params ); #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_functions.h" #line 50 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df_functions.h" extern int __cdecl dfsNewTask1D (DFTaskPtr *, const int , const float [], const int , const int , const float [], const int ); extern int __cdecl dfsnewtask1d (DFTaskPtr *, const int *, const float [], const int *, const int *, const float [], const int *); extern int __cdecl DFSNEWTASK1D (DFTaskPtr *, const int *, const float [], const int *, const int *, const float [], const int *); extern int __cdecl dfdNewTask1D (DFTaskPtr *, const int , const double [], const int , const int , const double [], const int ); extern int __cdecl dfdnewtask1d (DFTaskPtr *, const int *, const double [], const int *, const int *, const double [], const int *); extern int __cdecl DFDNEWTASK1D (DFTaskPtr *, const int *, const double [], const int *, const int *, const double [], const int *); extern int __cdecl dfsEditPtr (DFTaskPtr , const int , const float *); extern int __cdecl dfseditptr (DFTaskPtr *, const int *, const float *); extern int __cdecl DFSEDITPTR (DFTaskPtr *, const int *, const float *); extern int __cdecl dfdEditPtr (DFTaskPtr , const int , const double *); extern int __cdecl dfdeditptr (DFTaskPtr *, const int *, const double *); extern int __cdecl DFDEDITPTR (DFTaskPtr *, const int *, const double *); extern int __cdecl dfiEditVal (DFTaskPtr , const int , const int ); extern int __cdecl dfieditval (DFTaskPtr *, const int *, const int *); extern int __cdecl DFIEDITVAL (DFTaskPtr *, const int *, const int *); extern int __cdecl dfsEditIdxPtr (DFTaskPtr , const int , const int , const float []); extern int __cdecl dfseditidxptr (DFTaskPtr *, const int *, const int *, const float []); extern int __cdecl DFSEDITIDXPTR (DFTaskPtr *, const int *, const int *, const float []); extern int __cdecl dfdEditIdxPtr (DFTaskPtr , const int , const int , const double []); extern int __cdecl dfdeditidxptr (DFTaskPtr *, const int *, const int *, const double []); extern int __cdecl DFDEDITIDXPTR (DFTaskPtr *, const int *, const int *, const double []); extern int __cdecl dfsEditPPSpline1D (DFTaskPtr , const int , const int , const int , const float [], const int , const float [], const float [], const int ); extern int __cdecl dfseditppspline1d (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const float [], const float [], const int *); extern int __cdecl DFSEDITPPSPLINE1D (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const float [], const float [], const int *); extern int __cdecl dfdEditPPSpline1D (DFTaskPtr , const int , const int , const int , const double [], const int , const double [], const double [], const int ); extern int __cdecl dfdeditppspline1d (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const double [], const double [], const int *); extern int __cdecl DFDEDITPPSPLINE1D (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const double [], const double [], const int *); extern int __cdecl dfsQueryPtr (DFTaskPtr , const int , float **); extern int __cdecl dfsqueryptr (DFTaskPtr *, const int *, float **); extern int __cdecl DFSQUERYPTR (DFTaskPtr *, const int *, float **); extern int __cdecl dfdQueryPtr (DFTaskPtr , const int , double **); extern int __cdecl dfdqueryptr (DFTaskPtr *, const int *, double **); extern int __cdecl DFDQUERYPTR (DFTaskPtr *, const int *, double **); extern int __cdecl dfiQueryVal (DFTaskPtr , const int , int *); extern int __cdecl dfiqueryval (DFTaskPtr *, const int *, int *); extern int __cdecl DFIQUERYVAL (DFTaskPtr *, const int *, int *); extern int __cdecl dfsQueryIdxPtr (DFTaskPtr , const int , const int , float **); extern int __cdecl dfsqueryidxptr (DFTaskPtr *, const int *, const int *, float **); extern int __cdecl DFSQUERYIDXPTR (DFTaskPtr *, const int *, const int *, float **); extern int __cdecl dfdQueryIdxPtr (DFTaskPtr , const int , const int , double **); extern int __cdecl dfdqueryidxptr (DFTaskPtr *, const int *, const int *, double **); extern int __cdecl DFDQUERYIDXPTR (DFTaskPtr *, const int *, const int *, double **); extern int __cdecl dfsConstruct1D (DFTaskPtr , const int , const int ); extern int __cdecl dfsconstruct1d (DFTaskPtr *, const int *, const int *); extern int __cdecl DFSCONSTRUCT1D (DFTaskPtr *, const int *, const int *); extern int __cdecl dfdConstruct1D (DFTaskPtr , const int , const int ); extern int __cdecl dfdconstruct1d (DFTaskPtr *, const int *, const int *); extern int __cdecl DFDCONSTRUCT1D (DFTaskPtr *, const int *, const int *); extern int __cdecl dfsInterpolateEx1D (DFTaskPtr , const int , const int , const int , const float [], const int , const int , const int [], const float [], float [], const int , int [], const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfsinterpolateex1d (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [], const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl DFSINTERPOLATEEX1D (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [], const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsInterpCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfdInterpolateEx1D (DFTaskPtr , const int , const int , const int , const double [], const int , const int , const int [], const double [], double [], const int , int [], const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfdinterpolateex1d (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [], const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl DFDINTERPOLATEEX1D (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [], const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdInterpCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfsInterpolate1D (DFTaskPtr , const int , const int , const int , const float [], const int , const int , const int [], const float [], float [], const int , int [] ); extern int __cdecl dfsinterpolate1d (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [] ); extern int __cdecl DFSINTERPOLATE1D (DFTaskPtr *, const int *, const int *, const int *, const float [], const int *, const int *, const int [], const float [], float [], const int *, int [] ); extern int __cdecl dfdInterpolate1D (DFTaskPtr , const int , const int , const int , const double [], const int , const int , const int [], const double [], double [], const int , int [] ); extern int __cdecl dfdinterpolate1d (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [] ); extern int __cdecl DFDINTERPOLATE1D (DFTaskPtr *, const int *, const int *, const int *, const double [], const int *, const int *, const int [], const double [], double [], const int *, int [] ); extern int __cdecl dfsSearchCellsEx1D (DFTaskPtr , const int , const int , const float [], const int , const float [], int [], const dfsSearchCellsCallBack , const void * ); extern int __cdecl dfssearchcellsex1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [], const dfsSearchCellsCallBack , const void * ); extern int __cdecl DFSSEARCHCELLSEX1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [], const dfsSearchCellsCallBack , const void * ); extern int __cdecl dfdSearchCellsEx1D (DFTaskPtr , const int , const int , const double [], const int , const double [], int [], const dfdSearchCellsCallBack , const void * ); extern int __cdecl dfdsearchcellsex1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [], const dfdSearchCellsCallBack , const void * ); extern int __cdecl DFDSEARCHCELLSEX1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [], const dfdSearchCellsCallBack , const void * ); extern int __cdecl dfsSearchCells1D (DFTaskPtr , const int , const int , const float [], const int , const float [], int [] ); extern int __cdecl dfssearchcells1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [] ); extern int __cdecl DFSSEARCHCELLS1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], int [] ); extern int __cdecl dfdSearchCells1D (DFTaskPtr , const int , const int , const double [], const int , const double [], int [] ); extern int __cdecl dfdsearchcells1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [] ); extern int __cdecl DFDSEARCHCELLS1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], int [] ); extern int __cdecl dfsIntegrate1D (DFTaskPtr , const int , const int , const float [], const int , const float [], const int , const float [], const float [], float [], const int ); extern int __cdecl dfsintegrate1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *); extern int __cdecl DFSINTEGRATE1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *); extern int __cdecl dfdIntegrate1D (DFTaskPtr , const int , const int , const double [], const int , const double [], const int , const double [], const double [], double [], const int ); extern int __cdecl dfdintegrate1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *); extern int __cdecl DFDINTEGRATE1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *); extern int __cdecl dfsIntegrateEx1D (DFTaskPtr , const int , const int , const float [], const int , const float [], const int , const float [], const float [], float [], const int , const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfsintegrateex1d (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl DFSINTEGRATEEX1D (DFTaskPtr *, const int *, const int *, const float [], const int *, const float [], const int *, const float [], const float [], float [], const int *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsIntegrCallBack , const void *, const dfsSearchCellsCallBack , const void *); extern int __cdecl dfdIntegrateEx1D (DFTaskPtr , const int , const int , const double [], const int , const double [], const int , const double [], const double [], double [], const int , const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfdintegrateex1d (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl DFDINTEGRATEEX1D (DFTaskPtr *, const int *, const int *, const double [], const int *, const double [], const int *, const double [], const double [], double [], const int *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdIntegrCallBack , const void *, const dfdSearchCellsCallBack , const void *); extern int __cdecl dfDeleteTask (DFTaskPtr *); extern int __cdecl dfdeletetask (DFTaskPtr *); extern int __cdecl DFDELETETASK (DFTaskPtr *); #line 31 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_df.h" #line 52 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" #line 45 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" #line 58 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" enum DFTI_CONFIG_PARAM { DFTI_FORWARD_DOMAIN = 0, DFTI_DIMENSION = 1, DFTI_LENGTHS = 2, DFTI_PRECISION = 3, DFTI_FORWARD_SCALE = 4, DFTI_BACKWARD_SCALE = 5, DFTI_NUMBER_OF_TRANSFORMS = 7, DFTI_COMPLEX_STORAGE = 8, DFTI_REAL_STORAGE = 9, DFTI_CONJUGATE_EVEN_STORAGE = 10, DFTI_PLACEMENT = 11, DFTI_INPUT_STRIDES = 12, DFTI_OUTPUT_STRIDES = 13, DFTI_INPUT_DISTANCE = 14, DFTI_OUTPUT_DISTANCE = 15, DFTI_WORKSPACE = 17, DFTI_ORDERING = 18, DFTI_TRANSPOSE = 19, DFTI_DESCRIPTOR_NAME = 20, DFTI_PACKED_FORMAT = 21, DFTI_COMMIT_STATUS = 22, DFTI_VERSION = 23, DFTI_NUMBER_OF_USER_THREADS = 26, DFTI_THREAD_LIMIT = 27, DFTI_DESTROY_INPUT = 28 }; enum DFTI_CONFIG_VALUE { DFTI_COMMITTED = 30, DFTI_UNCOMMITTED = 31, DFTI_COMPLEX = 32, DFTI_REAL = 33, DFTI_SINGLE = 35, DFTI_DOUBLE = 36, DFTI_COMPLEX_COMPLEX = 39, DFTI_COMPLEX_REAL = 40, DFTI_REAL_COMPLEX = 41, DFTI_REAL_REAL = 42, DFTI_INPLACE = 43, DFTI_NOT_INPLACE = 44, DFTI_ORDERED = 48, DFTI_BACKWARD_SCRAMBLED = 49, DFTI_ALLOW = 51, DFTI_AVOID = 52, DFTI_NONE = 53, DFTI_CCS_FORMAT = 54, DFTI_PACK_FORMAT = 55, DFTI_PERM_FORMAT = 56, DFTI_CCE_FORMAT = 57 }; typedef struct DFTI_DESCRIPTOR *DFTI_DESCRIPTOR_HANDLE; typedef struct DFTI_DESCRIPTOR DFTI_DESCRIPTOR; long int DftiCreateDescriptor(DFTI_DESCRIPTOR_HANDLE*, enum DFTI_CONFIG_VALUE, enum DFTI_CONFIG_VALUE, long int, ...); long int DftiCopyDescriptor(DFTI_DESCRIPTOR_HANDLE, DFTI_DESCRIPTOR_HANDLE*); long int DftiCommitDescriptor(DFTI_DESCRIPTOR_HANDLE); long int DftiComputeForward(DFTI_DESCRIPTOR_HANDLE, void*, ...); long int DftiComputeBackward(DFTI_DESCRIPTOR_HANDLE, void*, ...); long int DftiSetValue(DFTI_DESCRIPTOR_HANDLE, enum DFTI_CONFIG_PARAM, ...); long int DftiGetValue(DFTI_DESCRIPTOR_HANDLE, enum DFTI_CONFIG_PARAM, ...); long int DftiFreeDescriptor(DFTI_DESCRIPTOR_HANDLE*); char* DftiErrorMessage(long int); long int DftiErrorClass(long int, long int); long int DftiCreateDescriptor_s_1d(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, ... ); long int DftiCreateDescriptor_s_md(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, long int many, ... ); long int DftiCreateDescriptor_d_1d(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, ... ); long int DftiCreateDescriptor_d_md(DFTI_DESCRIPTOR_HANDLE *, enum DFTI_CONFIG_VALUE domain, long int many, ... ); #line 274 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dfti.h" #line 54 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_trig_transforms.h" #line 38 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_trig_transforms.h" void d_init_trig_transform(int *, int *, int *, double *, int *); void d_commit_trig_transform(double *, DFTI_DESCRIPTOR_HANDLE *, int *, double *, int *); void d_forward_trig_transform(double *, DFTI_DESCRIPTOR_HANDLE *, int *, double *, int *); void d_backward_trig_transform(double *, DFTI_DESCRIPTOR_HANDLE *, int *, double *, int *); void s_init_trig_transform(int *, int *, int *, float *, int *); void s_commit_trig_transform(float *, DFTI_DESCRIPTOR_HANDLE *, int *, float *, int *); void s_forward_trig_transform(float *, DFTI_DESCRIPTOR_HANDLE *, int *, float *, int *); void s_backward_trig_transform(float *, DFTI_DESCRIPTOR_HANDLE *, int *, float *, int *); void free_trig_transform(DFTI_DESCRIPTOR_HANDLE *, int *, int *); #line 55 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_poisson.h" void d_init_helmholtz_2d(const double*, const double*, const double*, const double*, const int*, const int*, const char*, const double*, int*, double*, int*); void d_commit_helmholtz_2d(double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE *, int*, double*,int*); void d_helmholtz_2d(double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE *, int*, const double*,int*); void free_helmholtz_2d(DFTI_DESCRIPTOR_HANDLE*, int*, int*); void d_init_helmholtz_3d(const double*, const double*, const double*, const double*, const double*, const double*, const int*, const int*, const int*, const char*, const double*, int*, double*, int*); void d_commit_helmholtz_3d(double*, const double*, const double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, double*, int*); void d_helmholtz_3d(double*, const double*, const double*, const double*, const double*, const double*, const double*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, const double*,int*); void free_helmholtz_3d(DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, int*); void s_init_helmholtz_2d(const float*, const float*, const float*, const float*, const int*, const int*, const char*, const float*, int*, float*, int*); void s_commit_helmholtz_2d(float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE *, int*, float*, int*); void s_helmholtz_2d(float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE *, int*, const float*, int*); void s_init_helmholtz_3d(const float*, const float*, const float*, const float*, const float*, const float*, const int*, const int*, const int*, const char*, const float*,int*,float*,int*); void s_commit_helmholtz_3d(float*, const float*, const float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, float*, int*); void s_helmholtz_3d(float*, const float*, const float*, const float*, const float*, const float*, const float*, DFTI_DESCRIPTOR_HANDLE*, DFTI_DESCRIPTOR_HANDLE*, int*, const float*,int*); void d_init_sph_p(const double*, const double*, const double*, const double*, const int*, const int*, const double*, int*, double*, int*); void d_commit_sph_p(double*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void d_sph_p(double*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void free_sph_p(DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,int*); void d_init_sph_np(const double*, const double*, const double*, const double*, const int*, const int*, const double*, int*, double*, int*); void d_commit_sph_np(double*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void d_sph_np(double*,DFTI_DESCRIPTOR_HANDLE*,int*,double*,int*); void free_sph_np(DFTI_DESCRIPTOR_HANDLE*,int*,int*); void s_init_sph_p(const float*, const float*, const float*, const float*, const int*, const int*, const float*, int*, float*,int*); void s_commit_sph_p(float*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); void s_sph_p(float*,DFTI_DESCRIPTOR_HANDLE*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); void s_init_sph_np(const float*, const float*, const float*, const float*, const int*, const int*, const float*, int*, float*,int*); void s_commit_sph_np(float*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); void s_sph_np(float*,DFTI_DESCRIPTOR_HANDLE*,int*,float*,int*); #line 56 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_solvers_ee.h" #line 41 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_solvers_ee.h" extern void __cdecl feastinit (int* fpm); extern void __cdecl FEASTINIT (int* fpm); extern void __cdecl dfeast_scsrev (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SCSREV (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl sfeast_sygv (const char* uplo , const int* n , const float* a , const int* lda , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SYGV (const char* uplo , const int* n , const float* a , const int* lda , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl sfeast_scsrev (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SCSREV (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl zfeast_hbgv (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , const int* klb , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HBGV (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , const int* klb , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl zfeast_hcsrev (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HCSREV (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl cfeast_hbev (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HBEV (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl zfeast_heev (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HEEV (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl zfeast_hcsrgv (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , const MKL_Complex16* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HCSRGV (const char* uplo , const int* n , const MKL_Complex16* sa , const int* isa , const int* jsa , const MKL_Complex16* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl sfeast_scsrgv (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , const float* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SCSRGV (const char* uplo , const int* n , const float* sa , const int* isa , const int* jsa , const float* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl dfeast_srci (int* ijob , const int* n , MKL_Complex16* ze , double* work , MKL_Complex16* workc , double* aq , double* sq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , double* q , int* m , double* res , int* info); extern void __cdecl DFEAST_SRCI (int* ijob , const int* n , MKL_Complex16* ze , double* work , MKL_Complex16* workc , double* aq , double* sq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , double* q , int* m , double* res , int* info); extern void __cdecl sfeast_sbev (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SBEV (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl dfeast_sygv (const char* uplo , const int* n , const double* a , const int* lda , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SYGV (const char* uplo , const int* n , const double* a , const int* lda , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl cfeast_hegv (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HEGV (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl zfeast_hrci (int* ijob , const int* n , MKL_Complex16* ze , MKL_Complex16* work , MKL_Complex16* workc , MKL_Complex16* zaq , MKL_Complex16* zsq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , MKL_Complex16* q , int* m , double* res , int* info); extern void __cdecl ZFEAST_HRCI (int* ijob , const int* n , MKL_Complex16* ze , MKL_Complex16* work , MKL_Complex16* workc , MKL_Complex16* zaq , MKL_Complex16* zsq , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* lambda , MKL_Complex16* q , int* m , double* res , int* info); extern void __cdecl cfeast_hrci (int* ijob , const int* n , MKL_Complex8* ze , MKL_Complex8* work , MKL_Complex8* workc , MKL_Complex8* zaq , MKL_Complex8* zsq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , MKL_Complex8* q , int* m , float* res , int* info); extern void __cdecl CFEAST_HRCI (int* ijob , const int* n , MKL_Complex8* ze , MKL_Complex8* work , MKL_Complex8* workc , MKL_Complex8* zaq , MKL_Complex8* zsq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , MKL_Complex8* q , int* m , float* res , int* info); extern void __cdecl zfeast_hegv (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HEGV (const char* uplo , const int* n , const MKL_Complex16* a , const int* lda , const MKL_Complex16* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl sfeast_srci (int* ijob , const int* n , MKL_Complex8* ze , float* work , MKL_Complex8* workc , float* aq , float* sq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , float* q , int* m , float* res , int* info); extern void __cdecl SFEAST_SRCI (int* ijob , const int* n , MKL_Complex8* ze , float* work , MKL_Complex8* workc , float* aq , float* sq , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* lambda , float* q , int* m , float* res , int* info); extern void __cdecl dfeast_scsrgv (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , const double* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SCSRGV (const char* uplo , const int* n , const double* sa , const int* isa , const int* jsa , const double* sb , const int* isb , const int* jsb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl sfeast_syev (const char* uplo , const int* n , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SYEV (const char* uplo , const int* n , const float* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl cfeast_hcsrev (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HCSREV (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl zfeast_hbev (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl ZFEAST_HBEV (const char* uplo , const int* n , const int* kla , const MKL_Complex16* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , MKL_Complex16* x , int* m , double* res , int* info); extern void __cdecl dfeast_sbgv (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , const int* klb , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SBGV (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , const int* klb , const double* b , const int* ldb , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl cfeast_hbgv (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , const int* klb , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HBGV (const char* uplo , const int* n , const int* kla , const MKL_Complex8* a , const int* lda , const int* klb , const MKL_Complex8* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl cfeast_heev (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HEEV (const char* uplo , const int* n , const MKL_Complex8* a , const int* lda , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl sfeast_sbgv (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , const int* klb , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl SFEAST_SBGV (const char* uplo , const int* n , const int* kla , const float* a , const int* lda , const int* klb , const float* b , const int* ldb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , float* x , int* m , float* res , int* info); extern void __cdecl cfeast_hcsrgv (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , const MKL_Complex8* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl CFEAST_HCSRGV (const char* uplo , const int* n , const MKL_Complex8* sa , const int* isa , const int* jsa , const MKL_Complex8* sb , const int* isb , const int* jsb , int* fpm , float* epsout , int* loop , const float* emin , const float* emax , int* m0 , float* e , MKL_Complex8* x , int* m , float* res , int* info); extern void __cdecl dfeast_syev (const char* uplo , const int* n , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SYEV (const char* uplo , const int* n , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl dfeast_sbev (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); extern void __cdecl DFEAST_SBEV (const char* uplo , const int* n , const int* kla , const double* a , const int* lda , int* fpm , double* epsout , int* loop , const double* emin , const double* emax , int* m0 , double* e , double* x , int* m , double* res , int* info); #line 57 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_direct_call.h" #line 58 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\stdarg.h" #pragma once __pragma(pack(push, 8)) __pragma(pack(pop)) #line 19 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn_types.h" typedef struct _uniPrimitive_s* dnnPrimitive_t; typedef struct _dnnLayout_s* dnnLayout_t; typedef void* dnnPrimitiveAttributes_t; typedef enum { E_SUCCESS = 0, E_INCORRECT_INPUT_PARAMETER = -1, E_UNEXPECTED_NULL_POINTER = -2, E_MEMORY_ERROR = -3, E_UNSUPPORTED_DIMENSION = -4, E_UNIMPLEMENTED = -127 } dnnError_t; typedef enum { dnnAlgorithmConvolutionGemm, dnnAlgorithmConvolutionDirect, dnnAlgorithmConvolutionFFT, dnnAlgorithmPoolingMax, dnnAlgorithmPoolingMin, dnnAlgorithmPoolingAvgExcludePadding, dnnAlgorithmPoolingAvg = dnnAlgorithmPoolingAvgExcludePadding, dnnAlgorithmPoolingAvgIncludePadding } dnnAlgorithm_t; typedef enum { dnnResourceSrc = 0, dnnResourceFrom = 0, dnnResourceDst = 1, dnnResourceTo = 1, dnnResourceFilter = 2, dnnResourceScaleShift = 2, dnnResourceBias = 3, dnnResourceMean = 3, dnnResourceDiffSrc = 4, dnnResourceDiffFilter = 5, dnnResourceDiffScaleShift = 5, dnnResourceDiffBias = 6, dnnResourceVariance = 6, dnnResourceDiffDst = 7, dnnResourceWorkspace = 8, dnnResourceMultipleSrc = 16, dnnResourceMultipleDst = 24, dnnResourceNumber = 32 } dnnResourceType_t; typedef enum { dnnBorderZeros = 0x0, dnnBorderZerosAsymm = 0x100, dnnBorderExtrapolation = 0x3 } dnnBorder_t; typedef enum { dnnUseInputMeanVariance = 0x1U, dnnUseScaleShift = 0x2U } dnnBatchNormalizationFlag_t; #line 22 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_dnn.h" dnnError_t dnnLayoutCreate_F32( dnnLayout_t *pLayout, size_t dimension, const size_t size[], const size_t strides[]); dnnError_t dnnLayoutCreateFromPrimitive_F32( dnnLayout_t *pLayout, const dnnPrimitive_t primitive, dnnResourceType_t type); size_t dnnLayoutSerializationBufferSize_F32(); dnnError_t dnnLayoutSerialize_F32(const dnnLayout_t layout, void *buf); dnnError_t dnnLayoutDeserialize_F32(dnnLayout_t *pLayout, const void *buf); size_t dnnLayoutGetMemorySize_F32( const dnnLayout_t layout); int dnnLayoutCompare_F32( const dnnLayout_t l1, const dnnLayout_t l2); dnnError_t dnnAllocateBuffer_F32( void **pPtr, dnnLayout_t layout); dnnError_t dnnReleaseBuffer_F32( void *ptr); dnnError_t dnnLayoutDelete_F32( dnnLayout_t layout); dnnError_t dnnPrimitiveAttributesCreate_F32( dnnPrimitiveAttributes_t *attributes); dnnError_t dnnPrimitiveAttributesDestroy_F32( dnnPrimitiveAttributes_t attributes); dnnError_t dnnPrimitiveGetAttributes_F32( dnnPrimitive_t primitive, dnnPrimitiveAttributes_t *attributes); dnnError_t dnnExecute_F32( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnExecuteAsync_F32( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnWaitFor_F32( dnnPrimitive_t primitive); dnnError_t dnnDelete_F32( dnnPrimitive_t primitive); dnnError_t dnnConversionCreate_F32( dnnPrimitive_t* pConversion, const dnnLayout_t from, const dnnLayout_t to); dnnError_t dnnConversionExecute_F32( dnnPrimitive_t conversion, void *from, void *to); dnnError_t dnnSumCreate_F32( dnnPrimitive_t *pSum, dnnPrimitiveAttributes_t attributes, const size_t nSummands, dnnLayout_t layout, float *coefficients); dnnError_t dnnConcatCreate_F32( dnnPrimitive_t* pConcat, dnnPrimitiveAttributes_t attributes, const size_t nSrcTensors, dnnLayout_t *src); dnnError_t dnnSplitCreate_F32( dnnPrimitive_t *pSplit, dnnPrimitiveAttributes_t attributes, const size_t nDstTensors, dnnLayout_t layout, size_t dstChannelSize[]); dnnError_t dnnScaleCreate_F32( dnnPrimitive_t *pScale, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float alpha); dnnError_t dnnConvolutionCreateForward_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateForwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardData_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardFilter_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t dstSize[]); dnnError_t dnnGroupsConvolutionCreateForward_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateForwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardData_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardFilter_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardBias_F32( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t dstSize[]); dnnError_t dnnReLUCreateForward_F32( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float negativeSlope); dnnError_t dnnReLUCreateBackward_F32( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, float negativeSlope); dnnError_t dnnLRNCreateForward_F32( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, size_t kernel_size, float alpha, float beta, float k); dnnError_t dnnLRNCreateBackward_F32( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, size_t kernel_size, float alpha, float beta, float k); dnnError_t dnnBatchNormalizationCreateForward_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps); dnnError_t dnnBatchNormalizationCreateBackwardScaleShift_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps); dnnError_t dnnBatchNormalizationCreateBackwardData_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps); dnnError_t dnnBatchNormalizationCreateForward_v2_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps, unsigned int flags); dnnError_t dnnBatchNormalizationCreateBackward_v2_F32( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, float eps, unsigned int flags); dnnError_t dnnPoolingCreateForward_F32( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnPoolingCreateBackward_F32( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnInnerProductCreateForward_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateForwardBias_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardData_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardFilter_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardBias_F32( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t dstSize[]); dnnError_t dnnLayoutCreate_F64 ( dnnLayout_t *pLayout, size_t dimension, const size_t size[], const size_t strides[]); dnnError_t dnnLayoutCreateFromPrimitive_F64( dnnLayout_t *pLayout, const dnnPrimitive_t primitive, dnnResourceType_t type); size_t dnnLayoutSerializationBufferSize_F64(); dnnError_t dnnLayoutSerialize_F64(const dnnLayout_t layout, void *buf); dnnError_t dnnLayoutDeserialize_F64(dnnLayout_t *pLayout, const void *buf); size_t dnnLayoutGetMemorySize_F64( const dnnLayout_t layout); int dnnLayoutCompare_F64( const dnnLayout_t l1, const dnnLayout_t l2); dnnError_t dnnAllocateBuffer_F64( void **pPtr, dnnLayout_t layout); dnnError_t dnnReleaseBuffer_F64( void *ptr); dnnError_t dnnLayoutDelete_F64( dnnLayout_t layout); dnnError_t dnnPrimitiveAttributesCreate_F64( dnnPrimitiveAttributes_t *attributes); dnnError_t dnnPrimitiveAttributesDestroy_F64( dnnPrimitiveAttributes_t attributes); dnnError_t dnnPrimitiveGetAttributes_F64( dnnPrimitive_t primitive, dnnPrimitiveAttributes_t *attributes); dnnError_t dnnExecute_F64( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnExecuteAsync_F64( dnnPrimitive_t primitive, void *resources[]); dnnError_t dnnWaitFor_F64( dnnPrimitive_t primitive); dnnError_t dnnDelete_F64( dnnPrimitive_t primitive); dnnError_t dnnConversionCreate_F64( dnnPrimitive_t* pConversion, const dnnLayout_t from, const dnnLayout_t to); dnnError_t dnnConversionExecute_F64( dnnPrimitive_t conversion, void *from, void *to); dnnError_t dnnSumCreate_F64( dnnPrimitive_t *pSum, dnnPrimitiveAttributes_t attributes, const size_t nSummands, dnnLayout_t layout, double *coefficients); dnnError_t dnnConcatCreate_F64( dnnPrimitive_t* pConcat, dnnPrimitiveAttributes_t attributes, const size_t nSrcTensors, dnnLayout_t *src); dnnError_t dnnSplitCreate_F64( dnnPrimitive_t *pSplit, dnnPrimitiveAttributes_t attributes, const size_t nDstTensors, dnnLayout_t layout, size_t dstChannelSize[]); dnnError_t dnnScaleCreate_F64( dnnPrimitive_t *pScale, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double alpha); dnnError_t dnnConvolutionCreateForward_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateForwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardData_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardFilter_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnConvolutionCreateBackwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t dimension, const size_t dstSize[]); dnnError_t dnnGroupsConvolutionCreateForward_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateForwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardData_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardFilter_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t srcSize[], const size_t dstSize[], const size_t filterSize[], const size_t convolutionStrides[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnGroupsConvolutionCreateBackwardBias_F64( dnnPrimitive_t* pConvolution, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t algorithm, size_t groups, size_t dimension, const size_t dstSize[]); dnnError_t dnnReLUCreateForward_F64( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double negativeSlope); dnnError_t dnnReLUCreateBackward_F64( dnnPrimitive_t* pRelu, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, double negativeSlope); dnnError_t dnnLRNCreateForward_F64( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, size_t kernel_size, double alpha, double beta, double k); dnnError_t dnnLRNCreateBackward_F64( dnnPrimitive_t* pLrn, dnnPrimitiveAttributes_t attributes, const dnnLayout_t diffLayout, const dnnLayout_t dataLayout, size_t kernel_size, double alpha, double beta, double k); dnnError_t dnnBatchNormalizationCreateForward_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps); dnnError_t dnnBatchNormalizationCreateBackwardScaleShift_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps); dnnError_t dnnBatchNormalizationCreateBackwardData_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps); dnnError_t dnnBatchNormalizationCreateForward_v2_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps, unsigned int flags); dnnError_t dnnBatchNormalizationCreateBackward_v2_F64( dnnPrimitive_t* pBatchNormalization, dnnPrimitiveAttributes_t attributes, const dnnLayout_t dataLayout, double eps, unsigned int flags); dnnError_t dnnPoolingCreateForward_F64( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnPoolingCreateBackward_F64( dnnPrimitive_t* pPooling, dnnPrimitiveAttributes_t attributes, dnnAlgorithm_t op, const dnnLayout_t srcLayout, const size_t kernelSize[], const size_t kernelStride[], const int inputOffset[], const dnnBorder_t borderType); dnnError_t dnnInnerProductCreateForward_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateForwardBias_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardData_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardFilter_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t srcSize[], size_t outputChannels); dnnError_t dnnInnerProductCreateBackwardBias_F64( dnnPrimitive_t *pInnerProduct, dnnPrimitiveAttributes_t attributes, size_t dimensions, const size_t dstSize[]); #line 59 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_compact.h" MKL_COMPACT_PACK mkl_get_format_compact( void ); int mkl_sget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_sgepack_compact( MKL_LAYOUT layout, int rows, int columns, const float * const *a, int lda, float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_sgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, float * const *a, int lda, const float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_sgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, float alpha, const float *ap, int ldap, const float *bp, int ldbp, float beta, float *cp, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_strsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, float alpha, const float *ap, int ldap, float *bp, int ldbp, MKL_COMPACT_PACK format, int nm ); int mkl_dget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_dgepack_compact( MKL_LAYOUT layout, int rows, int columns, const double * const *a, int lda, double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_dgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, double * const *a, int lda, const double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_dgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, double alpha, const double *a, int ldap, const double *b, int ldbp, double beta, double *c, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_dtrsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, double alpha, const double *a, int ldap, double *b, int ldbp, MKL_COMPACT_PACK format, int nm ); int mkl_cget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_cgepack_compact( MKL_LAYOUT layout, int rows, int columns, const MKL_Complex8 * const *a, int lda, float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_cgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, MKL_Complex8 * const *a, int lda, const float *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_cgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, const MKL_Complex8 *alpha, const float *a, int ldap, const float *b, int ldbp, const MKL_Complex8 *beta, float *c, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_ctrsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, const MKL_Complex8 *alpha, const float *a, int ldap, float *b, int ldbp, MKL_COMPACT_PACK format, int nm ); int mkl_zget_size_compact( int ld, int sd, MKL_COMPACT_PACK format, int nm ); void mkl_zgepack_compact( MKL_LAYOUT layout, int rows, int columns, const MKL_Complex16 * const *a, int lda, double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_zgeunpack_compact( MKL_LAYOUT layout, int rows, int columns, MKL_Complex16 * const *a, int lda, const double *ap, int ldap, MKL_COMPACT_PACK format, int nm ); void mkl_zgemm_compact( MKL_LAYOUT layout, MKL_TRANSPOSE transa, MKL_TRANSPOSE transb, int m, int n, int k, const MKL_Complex16 *alpha, const double *a, int ldap, const double *b, int ldbp, const MKL_Complex16 *beta, double *c, int ldcp, MKL_COMPACT_PACK format, int nm ); void mkl_ztrsm_compact( MKL_LAYOUT layout, MKL_SIDE side, MKL_UPLO uplo, MKL_TRANSPOSE transa, MKL_DIAG diag, int m, int n, const MKL_Complex16 *alpha, const double *a, int ldap, double *b, int ldbp, MKL_COMPACT_PACK format, int nm ); void mkl_cgetrinp_compact( MKL_LAYOUT layout, int n, float* ap, int ldap, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dgetrinp_compact( MKL_LAYOUT layout, int n, double* ap, int ldap, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_sgetrinp_compact( MKL_LAYOUT layout, int n, float* ap, int ldap, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zgetrinp_compact( MKL_LAYOUT layout, int n, double* ap, int ldap, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_cgetrfnp_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dgetrfnp_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_sgetrfnp_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zgetrfnp_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_cpotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dpotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_spotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, float* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zpotrf_compact( MKL_LAYOUT layout, MKL_UPLO uplo, int n, double* ap, int ldap, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_cgeqrf_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, float* taup, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_dgeqrf_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, double* taup, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_sgeqrf_compact( MKL_LAYOUT layout, int m, int n, float* ap, int ldap, float* taup, float* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); void mkl_zgeqrf_compact( MKL_LAYOUT layout, int m, int n, double* ap, int ldap, double* taup, double* work, int lwork, int* info, MKL_COMPACT_PACK format, int nm ); #line 60 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl.h" #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Checking include with compiler flags var CPPFLAGS [] Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers/conftest.c stdout: conftest.c #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\confdefs.h" #line 2 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" typedef int int32_t; typedef int mode_t; typedef int pid_t; #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" #pragma once #line 1 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #pragma once #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #pragma once #line 46 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma once #line 179 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 188 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 200 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 207 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 223 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 324 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 351 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 496 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 503 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 540 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 576 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 596 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 603 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma region Input Buffer SAL 1 compatibility macros #line 1007 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1291 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1382 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1390 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1410 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #pragma endregion Input Buffer SAL 1 compatibility macros #line 1555 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1611 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1663 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2047 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2061 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2083 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2091 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2367 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2624 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2835 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2858 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2868 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2878 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2891 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2899 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2911 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 2945 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #pragma once #line 265 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 286 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 305 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 331 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 344 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\concurrencysal.h" #line 2971 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\sal.h" #line 48 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 1 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma once #pragma pack(push, 8) typedef unsigned __int64 uintptr_t; typedef char* va_list; #line 61 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 111 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" void __cdecl __va_start(va_list* , ...); #line 120 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #line 159 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vadefs.h" #pragma pack(pop) #line 49 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 74 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" __pragma(pack(push, 8)) #line 94 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 118 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 126 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 135 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 174 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef unsigned __int64 size_t; typedef __int64 ptrdiff_t; typedef __int64 intptr_t; #line 196 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" typedef _Bool __vcrt_bool; typedef unsigned short wchar_t; #line 225 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 243 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 262 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" #line 275 "e:\\Program Files (x86)\\Microsoft Visual Studio\\2017\\Enterprise\\VC\\Tools\\MSVC\\14.15.26726\\include\\vcruntime.h" void __cdecl __security_init_cookie(void); void __cdecl __security_check_cookie( uintptr_t _StackCookie); __declspec(noreturn) void __cdecl __report_gsfailure( uintptr_t _StackCookie); extern uintptr_t __security_cookie; __pragma(pack(pop)) #line 11 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(push, 8)) #line 30 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 46 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 66 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 88 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 98 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 137 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 145 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef _Bool __crt_bool; #line 167 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 184 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 216 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 228 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 252 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" void __cdecl _invalid_parameter_noinfo(void); __declspec(noreturn) void __cdecl _invalid_parameter_noinfo_noreturn(void); __declspec(noreturn) void __cdecl _invoke_watson( wchar_t const* _Expression, wchar_t const* _FunctionName, wchar_t const* _FileName, unsigned int _LineNo, uintptr_t _Reserved); #line 311 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 330 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 338 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 356 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 372 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 401 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 422 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 431 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 441 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 453 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 461 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 470 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" typedef int errno_t; typedef unsigned short wint_t; typedef unsigned short wctype_t; typedef long __time32_t; typedef __int64 __time64_t; typedef struct __crt_locale_data_public { unsigned short const* _locale_pctype; int _locale_mb_cur_max; unsigned int _locale_lc_codepage; } __crt_locale_data_public; typedef struct __crt_locale_pointers { struct __crt_locale_data* locinfo; struct __crt_multibyte_data* mbcinfo; } __crt_locale_pointers; typedef __crt_locale_pointers* _locale_t; typedef struct _Mbstatet { unsigned long _Wchar; unsigned short _Byte, _State; } _Mbstatet; typedef _Mbstatet mbstate_t; typedef __time64_t time_t; typedef size_t rsize_t; #line 696 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 709 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1787 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" #line 1979 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\corecrt.h" __pragma(pack(pop)) #line 13 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" __pragma(pack(push, 8)) #line 26 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" int* __cdecl _errno(void); errno_t __cdecl _set_errno( int _Value); errno_t __cdecl _get_errno( int* _Value); #line 50 "C:\\Program Files (x86)\\Windows Kits\\10\\include\\10.0.17134.0\\ucrt\\stddef.h" extern unsigned long __cdecl __threadid(void); extern uintptr_t __cdecl __threadhandle(void); __pragma(pack(pop)) #line 16 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conffix.h" int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #line 3 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" #line 1 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef struct _MKL_Complex8 { float real; float imag; } MKL_Complex8; typedef struct _MKL_Complex16 { double real; double imag; } MKL_Complex16; typedef struct { int MajorVersion; int MinorVersion; int UpdateVersion; char * ProductStatus; char * Build; char * Processor; char * Platform; } MKLVersion; #line 65 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 78 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 87 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 103 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 135 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" #line 143 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_types.h" typedef enum { MKL_ROW_MAJOR = 101, MKL_COL_MAJOR = 102 } MKL_LAYOUT; typedef enum { MKL_NOTRANS = 111, MKL_TRANS = 112, MKL_CONJTRANS = 113 } MKL_TRANSPOSE; typedef enum { MKL_UPPER = 121, MKL_LOWER = 122 } MKL_UPLO; typedef enum { MKL_NONUNIT = 131, MKL_UNIT = 132 } MKL_DIAG; typedef enum { MKL_LEFT = 141, MKL_RIGHT = 142 } MKL_SIDE; typedef enum { MKL_COMPACT_SSE = 181, MKL_COMPACT_AVX = 182, MKL_COMPACT_AVX512 = 183 } MKL_COMPACT_PACK; #line 26 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" #line 35 "E:\\Program Files (x86)\\IntelSWTools\\compilers_and_libraries\\windows\\mkl\\include\\mkl_spblas.h" __declspec(deprecated) void mkl_scsrmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scsrsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrgemv(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrsymv(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scscmv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scscsv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_scoomv(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_scoosv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoogemv(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scoosymv(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_scootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void mkl_sdiamv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sdiasv (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiagemv(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiasymv(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void mkl_sskymv (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sskysv(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void mkl_sbsrmv (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void mkl_sbsrsv(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void mkl_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrgemv(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrsymv(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_cspblas_sbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void mkl_scsrmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scsrsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scscmm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scscsm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_scoomm(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_scoosm(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiamm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sdiasm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskysm (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_sskymm (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void mkl_sbsrsm(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSRSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRGEMV(const char *transa, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRSYMV(const char *uplo, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSCMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCSCSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SCOOMV(const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SCOOSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOGEMV(const char *transa, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOSYMV(const char *uplo, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *rowind, const int *colind, const int *nnz, const float *x, float *y); __declspec(deprecated) void MKL_SDIAMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SDIASV (const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIAGEMV(const char *transa, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIASYMV(const char *uplo, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *x, float *y); __declspec(deprecated) void MKL_SSKYMV (const char *transa, const int *m, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SSKYSV(const char *transa, const int *m, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *x, float *y); __declspec(deprecated) void MKL_SBSRMV (const char *transa, const int *m, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, const float *beta, float *y); __declspec(deprecated) void MKL_SBSRSV(const char *transa, const int *m, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *x, float *y); __declspec(deprecated) void MKL_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRGEMV(const char *transa, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRSYMV(const char *uplo, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_CSPBLAS_SBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const float *a, const int *ia, const int *ja, const float *x, float *y); __declspec(deprecated) void MKL_SCSRMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSRSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCSCSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOMM(const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SCOOSM(const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *rowind, const int *colind, const int *nnz, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIAMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SDIASM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *lval, const int *idiag, const int *ndiag, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYSM (const char *transa, const int *m, const int *n, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void MKL_SSKYMM (const char *transa, const int *m, const int *n, const int *k, const float *alpha, const char *matdescra, const float *val, const int *pntr, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, const float *beta, float *c, const int *ldc); __declspec(deprecated) void MKL_SBSRSM(const char *transa, const int *m, const int *n, const int *lb, const float *alpha, const char *matdescra, const float *val, const int *indx, const int *pntrb, const int *pntre, const float *b, const int *ldb, float *c, const int *ldc); __declspec(deprecated) void mkl_dcsrmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcsrsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrgemv(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrsymv(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcscmv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcscsv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dcoomv(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dcoosv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoogemv(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcoosymv(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void mkl_ddiamv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_ddiasv (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiagemv(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiasymv(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_ddiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void mkl_dskymv (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dskysv(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void mkl_dbsrmv (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void mkl_dbsrsv(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void mkl_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrgemv(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrsymv(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_cspblas_dbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void mkl_dcsrmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcsrsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscmm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcscsm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoomm(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dcoosm(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiamm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_ddiasm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskysm (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_dskymm (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void mkl_dbsrsm(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSRSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRGEMV(const char *transa, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRSYMV(const char *uplo, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSCMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCSCSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DCOOMV(const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DCOOSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOGEMV(const char *transa, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOSYMV(const char *uplo, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *rowind, const int *colind, const int *nnz, const double *x, double *y); __declspec(deprecated) void MKL_DDIAMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DDIASV (const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIAGEMV(const char *transa, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIASYMV(const char *uplo, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *x, double *y); __declspec(deprecated) void MKL_DSKYMV (const char *transa, const int *m, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DSKYSV(const char *transa, const int *m, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *x, double *y); __declspec(deprecated) void MKL_DBSRMV (const char *transa, const int *m, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, const double *beta, double *y); __declspec(deprecated) void MKL_DBSRSV(const char *transa, const int *m, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *x, double *y); __declspec(deprecated) void MKL_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRGEMV(const char *transa, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRSYMV(const char *uplo, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_CSPBLAS_DBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const double *a, const int *ia, const int *ja, const double *x, double *y); __declspec(deprecated) void MKL_DCSRMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSRSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCSCSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOMM(const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DCOOSM(const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *rowind, const int *colind, const int *nnz, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIAMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DDIASM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *lval, const int *idiag, const int *ndiag, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYSM (const char *transa, const int *m, const int *n, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void MKL_DSKYMM (const char *transa, const int *m, const int *n, const int *k, const double *alpha, const char *matdescra, const double *val, const int *pntr, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, const double *beta, double *c, const int *ldc); __declspec(deprecated) void MKL_DBSRSM(const char *transa, const int *m, const int *n, const int *lb, const double *alpha, const char *matdescra, const double *val, const int *indx, const int *pntrb, const int *pntre, const double *b, const int *ldb, double *c, const int *ldc); __declspec(deprecated) void mkl_ccsrmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrgemv(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrsymv(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscmv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccscsv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoomv(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoogemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccoosymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_ccootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiamv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasv (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiagemv(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiasymv(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskymv (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cskysv(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_cspblas_cbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void mkl_ccsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccsrsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccscsm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_ccoosm(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cdiasm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskysm (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_cbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRGEMV(const char *transa, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRSYMV(const char *uplo, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSCSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOSYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASV (const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIAGEMV(const char *transa, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIASYMV(const char *uplo, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSKYSV(const char *transa, const int *m, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, const MKL_Complex8 *beta, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CSPBLAS_CBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex8 *a, const int *ia, const int *ja, const MKL_Complex8 *x, MKL_Complex8 *y); __declspec(deprecated) void MKL_CCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CDIASM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *pntr, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, const MKL_Complex8 *beta, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void MKL_CBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex8 *alpha, const char *matdescra, const MKL_Complex8 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex8 *b, const int *ldb, MKL_Complex8 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrgemv(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrsymv(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscmv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcscsv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoomv(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoogemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcoosymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zcootrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiamv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasv (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiagemv(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiasymv(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zdiatrsv(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskymv (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zskysv(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrmv (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrgemv(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrsymv(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_cspblas_zbsrtrsv(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void mkl_zcsrmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcsrsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscmm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcscsm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoomm(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zcoosm(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiamm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zdiasm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskysm (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zskymm (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrmm(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_zbsrsm(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRGEMV(const char *transa, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRSYMV(const char *uplo, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSCSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOMV(const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOSYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZCOOTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASV (const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIAGEMV(const char *transa, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIASYMV(const char *uplo, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZDIATRSV(const char *uplo, const char *transa, const char *diag, const int *m, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYMV (const char *transa, const int *m, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZSKYSV(const char *transa, const int *m, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRMV (const char *transa, const int *m, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, const MKL_Complex16 *beta, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRGEMV(const char *transa, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRSYMV(const char *uplo, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_CSPBLAS_ZBSRTRSV(const char *uplo, const char *transa, const char *diag, const int *m, const int *lb, const MKL_Complex16 *a, const int *ia, const int *ja, const MKL_Complex16 *x, MKL_Complex16 *y); __declspec(deprecated) void MKL_ZCSRMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSRSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCSCSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOMM(const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZCOOSM(const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *rowind, const int *colind, const int *nnz, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIAMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZDIASM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *lval, const int *idiag, const int *ndiag, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYSM (const char *transa, const int *m, const int *n, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZSKYMM (const char *transa, const int *m, const int *n, const int *k, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *pntr, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRMM(const char *transa, const int *m, const int *n, const int *k, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, const MKL_Complex16 *beta, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void MKL_ZBSRSM(const char *transa, const int *m, const int *n, const int *lb, const MKL_Complex16 *alpha, const char *matdescra, const MKL_Complex16 *val, const int *indx, const int *pntrb, const int *pntre, const MKL_Complex16 *b, const int *ldb, MKL_Complex16 *c, const int *ldc); __declspec(deprecated) void mkl_dcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_dcsrcoo(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_ddnscsr(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_dcsrcsc(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_dcsrdia(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_dcsrsky(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_scsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_scsrcoo(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_sdnscsr(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_scsrcsc(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_scsrdia(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_scsrsky(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_ccsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_ccsrcoo(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_cdnscsr(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_ccsrcsc(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_ccsrdia(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_ccsrsky(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_zcsrbsr(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void mkl_zcsrcoo(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void mkl_zdnscsr(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void mkl_zcsrcsc(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void mkl_zcsrdia(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void mkl_zcsrsky(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_DCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, double *Acsr, int *AJ, int *AI, double *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_DCSRCOO(const int *job, const int *n, double *Acsr, int *AJR, int *AIR, int *nnz, double *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_DDNSCSR(const int *job, const int *m, const int *n, double *Adns, const int *lda, double *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_DCSRCSC(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_DCSRDIA(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Adia, const int *ndiag, int *distance, int *idiag, double *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_DCSRSKY(const int *job, const int *n, double *Acsr, int *AJ0, int *AI0, double *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_SCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, float *Acsr, int *AJ, int *AI, float *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_SCSRCOO(const int *job, const int *n, float *Acsr, int *AJR, int *AIR, int *nnz, float *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_SDNSCSR(const int *job, const int *m, const int *n, float *Adns, const int *lda, float *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_SCSRCSC(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_SCSRDIA(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Adia, const int *ndiag, int *distance, int *idiag, float *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_SCSRSKY(const int *job, const int *n, float *Acsr, int *AJ0, int *AI0, float *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_CCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex8 *Acsr, int *AJ, int *AI, MKL_Complex8 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_CCSRCOO(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex8 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_CDNSCSR(const int *job, const int *m, const int *n, MKL_Complex8 *Adns, const int *lda, MKL_Complex8 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_CCSRCSC(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_CCSRDIA(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex8 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_CCSRSKY(const int *job, const int *n, MKL_Complex8 *Acsr, int *AJ0, int *AI0, MKL_Complex8 *Asky, int *pointers, int *info); __declspec(deprecated) void MKL_ZCSRBSR(const int *job, const int *m, const int *mblk, const int *ldAbsr, MKL_Complex16 *Acsr, int *AJ, int *AI, MKL_Complex16 *Absr, int *AJB, int *AIB, int *info); __declspec(deprecated) void MKL_ZCSRCOO(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJR, int *AIR, int *nnz, MKL_Complex16 *Acoo, int *ir, int *jc, int *info); __declspec(deprecated) void MKL_ZDNSCSR(const int *job, const int *m, const int *n, MKL_Complex16 *Adns, const int *lda, MKL_Complex16 *Acsr, int *AJ, int *AI, int *info); __declspec(deprecated) void MKL_ZCSRCSC(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Acsc, int *AJ1, int *AI1, int *info); __declspec(deprecated) void MKL_ZCSRDIA(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Adia, const int *ndiag, int *distance, int *idiag, MKL_Complex16 *Acsr_rem, int *AJ0_rem, int *AI0_rem, int *info); __declspec(deprecated) void MKL_ZCSRSKY(const int *job, const int *n, MKL_Complex16 *Acsr, int *AJ0, int *AI0, MKL_Complex16 *Asky, int *pointers, int *info); __declspec(deprecated) void mkl_dcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_dcsrmultd(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void mkl_dcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_scsrmultd(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void mkl_scsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_ccsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void mkl_ccsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultcsr(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void mkl_zcsrmultd(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void mkl_zcsradd(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_DCSRMULTD(const char *transa, const int *m, const int *n, const int *k, double *a, int *ja, int *ia, double *b, int *jb, int *ib, double *c, int *ldc); __declspec(deprecated) void MKL_DCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, double *a, int *ja, int *ia, const double *beta, double *b, int *jb, int *ib, double *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_SCSRMULTD(const char *transa, const int *m, const int *n, const int *k, float *a, int *ja, int *ia, float *b, int *jb, int *ib, float *c, int *ldc); __declspec(deprecated) void MKL_SCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, float *a, int *ja, int *ia, const float *beta, float *b, int *jb, int *ib, float *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_CCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex8 *a, int *ja, int *ia, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *ldc); __declspec(deprecated) void MKL_CCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex8 *a, int *ja, int *ia, const MKL_Complex8 *beta, MKL_Complex8 *b, int *jb, int *ib, MKL_Complex8 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTCSR(const char *transa, const int *job, const int *sort, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); __declspec(deprecated) void MKL_ZCSRMULTD(const char *transa, const int *m, const int *n, const int *k, MKL_Complex16 *a, int *ja, int *ia, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *ldc); __declspec(deprecated) void MKL_ZCSRADD(const char *transa, const int *job, const int *sort, const int *m, const int *n, MKL_Complex16 *a, int *ja, int *ia, const MKL_Complex16 *beta, MKL_Complex16 *b, int *jb, int *ib, MKL_Complex16 *c, int *jc, int *ic, const int *nnzmax, int *ierr); typedef enum { SPARSE_STATUS_SUCCESS = 0, SPARSE_STATUS_NOT_INITIALIZED = 1, SPARSE_STATUS_ALLOC_FAILED = 2, SPARSE_STATUS_INVALID_VALUE = 3, SPARSE_STATUS_EXECUTION_FAILED = 4, SPARSE_STATUS_INTERNAL_ERROR = 5, SPARSE_STATUS_NOT_SUPPORTED = 6 } sparse_status_t; typedef enum { SPARSE_OPERATION_NON_TRANSPOSE = 10, SPARSE_OPERATION_TRANSPOSE = 11, SPARSE_OPERATION_CONJUGATE_TRANSPOSE = 12 } sparse_operation_t; typedef enum { SPARSE_MATRIX_TYPE_GENERAL = 20, SPARSE_MATRIX_TYPE_SYMMETRIC = 21, SPARSE_MATRIX_TYPE_HERMITIAN = 22, SPARSE_MATRIX_TYPE_TRIANGULAR = 23, SPARSE_MATRIX_TYPE_DIAGONAL = 24, SPARSE_MATRIX_TYPE_BLOCK_TRIANGULAR = 25, SPARSE_MATRIX_TYPE_BLOCK_DIAGONAL = 26 } sparse_matrix_type_t; typedef enum { SPARSE_INDEX_BASE_ZERO = 0, SPARSE_INDEX_BASE_ONE = 1 } sparse_index_base_t; typedef enum { SPARSE_FILL_MODE_LOWER = 40, SPARSE_FILL_MODE_UPPER = 41, SPARSE_FILL_MODE_FULL = 42 } sparse_fill_mode_t; typedef enum { SPARSE_DIAG_NON_UNIT = 50, SPARSE_DIAG_UNIT = 51 } sparse_diag_type_t; typedef enum { SPARSE_LAYOUT_ROW_MAJOR = 101, SPARSE_LAYOUT_COLUMN_MAJOR = 102 } sparse_layout_t; typedef enum { SPARSE_VERBOSE_OFF = 70, SPARSE_VERBOSE_BASIC = 71, SPARSE_VERBOSE_EXTENDED = 72 } verbose_mode_t; typedef enum { SPARSE_MEMORY_NONE = 80, SPARSE_MEMORY_AGGRESSIVE = 81 } sparse_memory_usage_t; typedef enum { SPARSE_STAGE_FULL_MULT = 90, SPARSE_STAGE_NNZ_COUNT = 91, SPARSE_STAGE_FINALIZE_MULT = 92, SPARSE_STAGE_FULL_MULT_NO_VAL = 93, SPARSE_STAGE_FINALIZE_MULT_NO_VAL = 94 } sparse_request_t; struct sparse_matrix; typedef struct sparse_matrix *sparse_matrix_t; struct matrix_descr { sparse_matrix_type_t type; sparse_fill_mode_t mode; sparse_diag_type_t diag; }; sparse_status_t mkl_sparse_s_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_coo( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int nnz, int *row_indx, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csr( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_csc( sparse_matrix_t *A, sparse_index_base_t indexing, int rows, int cols, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_s_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, float *values ); sparse_status_t mkl_sparse_d_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, double *values ); sparse_status_t mkl_sparse_c_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex8 *values ); sparse_status_t mkl_sparse_z_create_bsr( sparse_matrix_t *A, sparse_index_base_t indexing, sparse_layout_t block_layout, int rows, int cols, int block_size, int *rows_start, int *rows_end, int *col_indx, MKL_Complex16 *values ); sparse_status_t mkl_sparse_copy( const sparse_matrix_t source, struct matrix_descr descr, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_destroy( sparse_matrix_t A ); sparse_status_t mkl_sparse_get_error_info( sparse_matrix_t A, int *info ); sparse_status_t mkl_sparse_convert_csr ( const sparse_matrix_t source, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_convert_bsr ( const sparse_matrix_t source, int block_size, sparse_layout_t block_layout, sparse_operation_t operation, sparse_matrix_t *dest ); sparse_status_t mkl_sparse_s_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_bsr( const sparse_matrix_t source, sparse_index_base_t *indexing, sparse_layout_t *block_layout, int *rows, int *cols, int *block_size, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csr( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, float **values ); sparse_status_t mkl_sparse_d_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, double **values ); sparse_status_t mkl_sparse_c_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex8 **values ); sparse_status_t mkl_sparse_z_export_csc( const sparse_matrix_t source, sparse_index_base_t *indexing, int *rows, int *cols, int **rows_start, int **rows_end, int **col_indx, MKL_Complex16 **values ); sparse_status_t mkl_sparse_s_set_value( sparse_matrix_t A, int row, int col, float value ); sparse_status_t mkl_sparse_d_set_value( sparse_matrix_t A, int row, int col, double value ); sparse_status_t mkl_sparse_c_set_value( sparse_matrix_t A, int row, int col, MKL_Complex8 value ); sparse_status_t mkl_sparse_z_set_value( sparse_matrix_t A, int row, int col, MKL_Complex16 value ); sparse_status_t mkl_sparse_set_verbose_mode ( verbose_mode_t verbose ); sparse_status_t mkl_sparse_set_mv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_mm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_sv_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_set_sm_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, sparse_layout_t layout, int dense_matrix_size, int expected_calls ); sparse_status_t mkl_sparse_set_memory_hint ( sparse_matrix_t A, sparse_memory_usage_t policy ); sparse_status_t mkl_sparse_optimize ( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_mv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y ); sparse_status_t mkl_sparse_d_mv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y ); sparse_status_t mkl_sparse_c_mv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_mv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_trsv ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float *y ); sparse_status_t mkl_sparse_d_trsv ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double *y ); sparse_status_t mkl_sparse_c_trsv ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 *y ); sparse_status_t mkl_sparse_z_trsv ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 *y ); sparse_status_t mkl_sparse_s_mm( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float beta, float *y, int ldy ); sparse_status_t mkl_sparse_d_mm( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double beta, double *y, int ldy ); sparse_status_t mkl_sparse_c_mm( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 beta, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_mm( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 beta, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_trsm ( sparse_operation_t operation, float alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const float *x, int columns, int ldx, float *y, int ldy ); sparse_status_t mkl_sparse_d_trsm ( sparse_operation_t operation, double alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const double *x, int columns, int ldx, double *y, int ldy ); sparse_status_t mkl_sparse_c_trsm ( sparse_operation_t operation, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex8 *x, int columns, int ldx, MKL_Complex8 *y, int ldy ); sparse_status_t mkl_sparse_z_trsm ( sparse_operation_t operation, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, sparse_layout_t layout, const MKL_Complex16 *x, int columns, int ldx, MKL_Complex16 *y, int ldy ); sparse_status_t mkl_sparse_s_add( sparse_operation_t operation, const sparse_matrix_t A, float alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_d_add( sparse_operation_t operation, const sparse_matrix_t A, double alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_c_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_z_add( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_spmm( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sp2m ( sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, sparse_request_t request, sparse_matrix_t *C ); sparse_status_t mkl_sparse_syrk ( sparse_operation_t operation, const sparse_matrix_t A, sparse_matrix_t *C ); sparse_status_t mkl_sparse_sypr ( sparse_operation_t transA, const sparse_matrix_t A, const sparse_matrix_t B, struct matrix_descr descrB, sparse_matrix_t *C, sparse_request_t request ); sparse_status_t mkl_sparse_s_syprd ( const sparse_operation_t op, const sparse_matrix_t A, float *B, const sparse_layout_t layoutB, const int ldb, float alpha, float beta, float *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_d_syprd ( const sparse_operation_t op, const sparse_matrix_t A, double *B, const sparse_layout_t layoutB, const int ldb, double alpha, double beta, double *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_c_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex8 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_z_syprd ( const sparse_operation_t op, const sparse_matrix_t A, MKL_Complex16 *B, const sparse_layout_t layoutB, const int ldb, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layoutC, const int ldc ); sparse_status_t mkl_sparse_order( sparse_matrix_t A ); sparse_status_t mkl_sparse_s_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, float *C, int ldc ); sparse_status_t mkl_sparse_d_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, double *C, int ldc ); sparse_status_t mkl_sparse_c_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex8 *C, int ldc ); sparse_status_t mkl_sparse_z_spmmd( sparse_operation_t operation, const sparse_matrix_t A, const sparse_matrix_t B, sparse_layout_t layout, MKL_Complex16 *C, int ldc ); sparse_status_t mkl_sparse_d_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const double alpha, const double beta, double *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_s_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const float alpha, const float beta, float *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_z_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex16 alpha, const MKL_Complex16 beta, MKL_Complex16 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_c_sp2md ( const sparse_operation_t transA, struct matrix_descr descrA, const sparse_matrix_t A, const sparse_operation_t transB, struct matrix_descr descrB, const sparse_matrix_t B, const MKL_Complex8 alpha, const MKL_Complex8 beta, MKL_Complex8 *C, const sparse_layout_t layout, const int ldc ); sparse_status_t mkl_sparse_set_symgs_hint ( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expected_calls ); sparse_status_t mkl_sparse_d_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x, double *y); sparse_status_t mkl_sparse_d_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const double alpha, double *b, double *x); sparse_status_t mkl_sparse_set_dotmv_hint( sparse_matrix_t A, sparse_operation_t operation, struct matrix_descr descr, int expectedCalls ); sparse_status_t mkl_sparse_d_dotmv( sparse_operation_t transA, double alpha, const sparse_matrix_t A, struct matrix_descr descr, const double *x, double beta, double *y, double *d ); sparse_status_t mkl_sparse_s_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x, float *y); sparse_status_t mkl_sparse_s_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const float alpha, float *b, float *x); sparse_status_t mkl_sparse_s_dotmv( sparse_operation_t transA, float alpha, const sparse_matrix_t A, struct matrix_descr descr, const float *x, float beta, float *y, float *d ); sparse_status_t mkl_sparse_c_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x, MKL_Complex8 *y); sparse_status_t mkl_sparse_c_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 alpha, MKL_Complex8 *b, MKL_Complex8 *x); sparse_status_t mkl_sparse_c_dotmv( sparse_operation_t transA, MKL_Complex8 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex8 *x, MKL_Complex8 beta, MKL_Complex8 *y, MKL_Complex8 *d ); sparse_status_t mkl_sparse_z_symgs_mv ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x, MKL_Complex16 *y); sparse_status_t mkl_sparse_z_symgs ( const sparse_operation_t op, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 alpha, MKL_Complex16 *b, MKL_Complex16 *x); sparse_status_t mkl_sparse_z_dotmv( sparse_operation_t transA, MKL_Complex16 alpha, const sparse_matrix_t A, struct matrix_descr descr, const MKL_Complex16 *x, MKL_Complex16 beta, MKL_Complex16 *y, MKL_Complex16 *d ); sparse_status_t mkl_sparse_s_syrkd( sparse_operation_t operation, const sparse_matrix_t A, float alpha, float beta, float *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_d_syrkd( sparse_operation_t operation, const sparse_matrix_t A, double alpha, double beta, double *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_c_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex8 alpha, MKL_Complex8 beta, MKL_Complex8 *C, sparse_layout_t layout, int ldc ); sparse_status_t mkl_sparse_z_syrkd( sparse_operation_t operation, const sparse_matrix_t A, MKL_Complex16 alpha, MKL_Complex16 beta, MKL_Complex16 *C, sparse_layout_t layout, int ldc ); #line 4 "C:\\Users\\AliReza\\AppData\\Local\\Temp\\petsc-fh63UE\\config.headers\\conftest.c" Preprocess stderr before filtering:: Preprocess stderr after filtering:: Found header files ['mkl.h', 'mkl_spblas.h'] in [] Popping language C ================================================================================ TEST checkSharedLibrary from config.packages.mkl_sparse(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:799) TESTING: checkSharedLibrary from config.packages.mkl_sparse(config/BuildSystem/config/package.py:799) By default we don't care about checking if the library is shared Popping language C ================================================================================ TEST alternateConfigureLibrary from config.packages.mkl_cpardiso(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.mkl_cpardiso(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.fftw(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.fftw(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default ================================================================================ TEST alternateConfigureLibrary from config.packages.elemental(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:803) TESTING: alternateConfigureLibrary from config.packages.elemental(config/BuildSystem/config/package.py:803) Called if --with-packagename=0; does nothing by default Checking for functions [DGELS] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DGELS(); static void _check_DGELS() { DGELS(); } int main() { _check_DGELS();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Defined "HAVE_LIBMKL_INTEL_LP64_DLL" to "1" Defined "HAVE_LIBMKL_INTEL_THREAD_DLL" to "1" Defined "HAVE_LIBMKL_CORE_DLL" to "1" Defined "HAVE_LIBIOMP5MD" to "1" Popping language C Checking for functions [DSTEQR] in library ['/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib', 'mkl_intel_thread_dll.lib', 'mkl_core_dll.lib', 'libiomp5md.lib'] [] Pushing language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -c -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.compilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.closure -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.setCompilers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.headers -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.cacheDetails -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.atomics -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.functions -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.featureTestMacros -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.utilities.missing -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/PETSc.options.scalarTypes -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.types -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.MPI -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.pthread -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.BlasLapack -I/cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.c stdout: conftest.c Successful compile: Source: #include "confdefs.h" #include "conffix.h" /* Override any gcc2 internal prototype to avoid an error. */ char DSTEQR(); static void _check_DSTEQR() { DSTEQR(); } int main() { _check_DSTEQR();; return 0; } Pushing language C Popping language C Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -o /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.exe -O2 -MT -wd4996 -Qopenmp /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.libraries/conftest.o /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib Ws2_32.lib Defined "HAVE_LIBMKL_INTEL_LP64_DLL" to "1" Defined "HAVE_LIBMKL_INTEL_THREAD_DLL" to "1" Defined "HAVE_LIBMKL_CORE_DLL" to "1" Defined "HAVE_LIBIOMP5MD" to "1" Popping language C Found dsteqr() in Lapack library as needed by ML Found dgels() in Lapack library as needed by ML Pushing language C ================================================================================ TEST checkDependencies from config.packages.ml(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:721) TESTING: checkDependencies from config.packages.ml(config/BuildSystem/config/package.py:721) ================================================================================ TEST configureLibrary from config.packages.ml(/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py:746) TESTING: configureLibrary from config.packages.ml(config/BuildSystem/config/package.py:746) Find an installation and check if it can work with PETSc ================================================================================== Checking for a functional ml Looking for ML at git.ml, hg.ml or a directory starting with ['petsc-pkg-ml'] Could not locate an existing copy of ML: [] Downloading ml =============================================================================== Trying to download git://https://bitbucket.org/petsc/pkg-ml.git for ML =============================================================================== Executing: git clone https://bitbucket.org/petsc/pkg-ml.git /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml Looking for ML at git.ml, hg.ml or a directory starting with ['petsc-pkg-ml'] Found a copy of ML in git.ml Executing: ['git', 'rev-parse', '--git-dir'] stdout: .git Executing: ['git', 'cat-file', '-e', 'v6.2-p4^{commit}'] Executing: ['git', 'rev-parse', 'v6.2-p4'] stdout: e5040d11aa071b70553014b1c009239ad07b4405 Executing: ['git', 'stash'] stdout: No local changes to save Executing: ['git', 'clean', '-f', '-d', '-x'] Executing: ['git', 'checkout', '-f', 'e5040d11aa071b70553014b1c009239ad07b4405'] Pushing language C All intermediate test results are stored in /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/config.packages.ml Popping language C Pushing language Cxx Popping language Cxx Pushing language FC Executing: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -v stdout: ifort: command line warning #10006: ignoring unknown option '/v' ifort: command line error: no files specified; for help type "ifort /help" Popping language FC Pushing language C Popping language C Pushing language FC Popping language FC Pushing language Cxx Popping language Cxx Have to rebuild ML, /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml/ml.petscconf != /home/alireza/petsc-3.9.3/arch-mswin-c-opt/lib/petsc/conf/pkg.conf.ml =============================================================================== Running configure on ML; this may take several minutes =============================================================================== Executing: cd /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml && ./configure --prefix=/home/alireza/Petsc393Install MAKE=/usr/bin/make --libdir=/home/alireza/Petsc393Install/lib CC="/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" CFLAGS="-O2 -MT -wd4996 -Qopenmp" AR="/usr/bin/ar" ARFLAGS="cr" CXX="/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" CXXFLAGS="-O2 -MT -wd4996 -Qopenmp -TP" F90="/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort" F90FLAGS="-MT -O2 -Qopenmp -fpp" F77="/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort" FFLAGS="-MT -O2 -Qopenmp -fpp" FC="/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort" FCFLAGS="-MT -O2 -Qopenmp -fpp" --disable-shared --disable-ml-epetra --disable-ml-aztecoo --disable-ml-examples --disable-tests --enable-libcheck --with-cflags="-O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include" CPPFLAGS="-I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include" --with-fflags="-MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include" --with-cxxflags="-O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include" --enable-mpi --with-mpi-libs="/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib" --with-blas="/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib" stdout: ---------------------------------------- Running ML Configure Script ---------------------------------------- checking whether to enable maintainer-specific portions of Makefiles... no checking build system type... x86_64-unknown-cygwin checking host system type... x86_64-unknown-cygwin checking target system type... x86_64-unknown-cygwin checking for a BSD-compatible install... /usr/bin/install -c checking whether build environment is sane... yes checking for a thread-safe mkdir -p... /usr/bin/mkdir -p checking for gawk... gawk checking whether /usr/bin/make sets $(MAKE)... yes checking whether /usr/bin/make supports nested variables... yes checking whether UID '197608' is supported by ustar format... yes checking whether GID '197121' is supported by ustar format... yes checking how to create a ustar tar archive... gnutar checking user-defined MPI libraries... /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib checking whether we are using MPI... yes checking whether the C++ compiler works... yes checking for C++ compiler default output file name... conftest.exe checking for suffix of executables... .exe checking whether we are cross compiling... no checking for suffix of object files... o checking whether we are using the GNU C++ compiler... no checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl accepts -g... yes checking for style of include used by /usr/bin/make... GNU checking dependency style of /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl... msvc7 checking whether we are using the GNU C compiler... no checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl accepts -g... yes checking for /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl option to accept ISO C89... none needed checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl understands -c and -o together... yes checking dependency style of /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl... msvc7 checking whether we are using the GNU Fortran 77 compiler... no checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort accepts -g... yes checking for ranlib... ranlib checking finding build directory... /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml checking whether additional CCFLAGS flags should be added... no checking whether additional CXXFLAGS flags should be added... CXXFLAGS = -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP checking whether additional CFLAGS flags should be added... CFLAGS = -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp checking whether additional FFLAGS flags should be added... FFLAGS = -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -MT -O2 -Qopenmp -fpp checking whether additional libraries are needed... no checking whether additional LDFLAGS flags should be added... no checking for special archiver command... none checking how to run the C++ preprocessor... /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E checking for mpi.h... yes checking whether to build export makefiles... yes checking for perl... yes checking whether gnumake specific code should be enabled... no checking for grep that handles long lines and -e... /usr/bin/grep checking for egrep... /usr/bin/grep -E checking for ANSI C header files... yes checking for sys/types.h... yes checking for sys/stat.h... yes checking for stdlib.h... yes checking for string.h... yes checking for memory.h... yes checking for strings.h... no checking for inttypes.h... yes checking for stdint.h... yes checking for unistd.h... no checking cstdlib usability... yes checking cstdlib presence... yes checking for cstdlib... yes checking cstdio usability... yes checking cstdio presence... yes checking for cstdio... yes checking cassert usability... yes checking cassert presence... yes checking for cassert... yes checking cmath usability... yes checking cmath presence... yes checking for cmath... yes checking iomanip usability... yes checking iomanip presence... yes checking for iomanip... yes checking iostream usability... yes checking iostream presence... yes checking for iostream... yes checking string usability... yes checking string presence... yes checking for string... yes checking malloc.h usability... yes checking malloc.h presence... yes checking for malloc.h... yes checking for inline... inline checking whether the compiler implements namespaces... yes checking whether the compiler supports Standard Template Library... yes checking whether the compiler recognizes bool as a built-in type... yes checking whether the compiler supports the mutable keyword... yes checking whether the compiler accepts the new for scoping rules... yes checking whether the compiler recognizes std::sprintf as supported IO function... yes checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl recognizes __PRETTY_FUNCTION__... yes checking whether to use ml_newtpe... yes checking whether to use ml_enrich... no checking whether to use ml_aztec2_1... no checking whether to use ml_complex_maxwell... no checking whether to use ml_timing... no checking whether to use ml_memory_checking... no checking whether to use ml_flops... no checking whether to use ml_benchmarking... no checking whether to use ml_superlu... no checking whether to use ml_superlu2... no checking whether to use ml_superlu_dist... no checking whether to use ml_metis... no checking whether to use ml_parmetis2x... no checking whether to use ml_parmetis3x... no checking whether to use ml_arpack... no checking whether to use ml_parpack... no checking whether to use ml_parasails... no checking whether to use ml_nox... no checking whether to use ml_zoltan... no checking whether to use ml_zoltan3... no checking whether to use petsc... no checking whether to build optional epetra dependent code in ml... no checking whether to build optional amesos dependent code in ml... no checking whether to build optional ifpack dependent code in ml... no checking whether to build optional teuchos dependent code in ml... no checking whether to build optional aztecoo dependent code in ml... no checking whether to build optional epetraext dependent code in ml... no checking whether to build optional isorropia dependent code in ml... no checking whether to build optional galeri dependent code in ml... no checking whether to use ml-examples... no checking whether to use tests... no checking whether to use ml-tests... no checking whether to use libcheck... yes checking whether additional library search paths defined... no checking whether additional include search paths defined... no checking how to get verbose linking output from /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort... --verbose checking for Fortran 77 libraries of /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort... -link checking for dummy main to link with Fortran 77 libraries... unknown **** Configure header /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/confdefs.h **** #if !defined(INCLUDED_UNKNOWN) #define INCLUDED_UNKNOWN #ifndef HAVE_MATH_INFINITY #define HAVE_MATH_INFINITY 1 #endif #ifndef IS_COLORING_MAX #define IS_COLORING_MAX 65535 #endif #ifndef STDC_HEADERS #define STDC_HEADERS 1 #endif #ifndef MPIU_COLORING_VALUE #define MPIU_COLORING_VALUE MPI_UNSIGNED_SHORT #endif #ifndef _USE_MATH_DEFINES #define _USE_MATH_DEFINES 1 #endif #ifndef PETSC_HAVE_GZIP #define PETSC_HAVE_GZIP 1 #endif #ifndef PETSC_HAVE_MALLOC_H #define PETSC_HAVE_MALLOC_H 1 #endif #ifndef PETSC_HAVE_IO_H #define PETSC_HAVE_IO_H 1 #endif #ifndef PETSC_HAVE_TIME_H #define PETSC_HAVE_TIME_H 1 #endif #ifndef PETSC_HAVE_MATH_H #define PETSC_HAVE_MATH_H 1 #endif #ifndef PETSC_HAVE_STRING_H #define PETSC_HAVE_STRING_H 1 #endif #ifndef PETSC_HAVE_FCNTL_H #define PETSC_HAVE_FCNTL_H 1 #endif #ifndef PETSC_HAVE_DIRECT_H #define PETSC_HAVE_DIRECT_H 1 #endif #ifndef PETSC_HAVE_WINDOWSX_H #define PETSC_HAVE_WINDOWSX_H 1 #endif #ifndef PETSC_HAVE_SYS_TYPES_H #define PETSC_HAVE_SYS_TYPES_H 1 #endif #ifndef PETSC_HAVE_INTTYPES_H #define PETSC_HAVE_INTTYPES_H 1 #endif #ifndef PETSC_HAVE_DOS_H #define PETSC_HAVE_DOS_H 1 #endif #ifndef PETSC_HAVE_IMMINTRIN_H #define PETSC_HAVE_IMMINTRIN_H 1 #endif #ifndef PETSC_HAVE_FLOAT_H #define PETSC_HAVE_FLOAT_H 1 #endif #ifndef PETSC_HAVE_STDLIB_H #define PETSC_HAVE_STDLIB_H 1 #endif #ifndef PETSC_HAVE_SEARCH_H #define PETSC_HAVE_SEARCH_H 1 #endif #ifndef PETSC_HAVE_SETJMP_H #define PETSC_HAVE_SETJMP_H 1 #endif #ifndef PETSC_HAVE_STDINT_H #define PETSC_HAVE_STDINT_H 1 #endif #ifndef PETSC_HAVE_WS2TCPIP_H #define PETSC_HAVE_WS2TCPIP_H 1 #endif #ifndef PETSC_HAVE_LIMITS_H #define PETSC_HAVE_LIMITS_H 1 #endif #ifndef PETSC_HAVE_C99 #define PETSC_HAVE_C99 1 #endif #ifndef PETSC_FORTRAN_CHARLEN_T #define PETSC_FORTRAN_CHARLEN_T int #endif #ifndef PETSC_HAVE_FORTRAN_CAPS #define PETSC_HAVE_FORTRAN_CAPS 1 #endif #ifndef PETSC_C_STATIC_INLINE #define PETSC_C_STATIC_INLINE static inline #endif #ifndef PETSC_HAVE_FORTRAN_FLUSH #define PETSC_HAVE_FORTRAN_FLUSH 1 #endif #ifndef PETSC_USING_F90FREEFORM #define PETSC_USING_F90FREEFORM 1 #endif #ifndef PETSC_USING_F90 #define PETSC_USING_F90 1 #endif #ifndef PETSC_HAVE_CXX_NAMESPACE #define PETSC_HAVE_CXX_NAMESPACE 1 #endif #ifndef PETSC_C_RESTRICT #define PETSC_C_RESTRICT __restrict #endif #ifndef PETSC_FORTRAN_TYPE_INITIALIZE #define PETSC_FORTRAN_TYPE_INITIALIZE = 0 #endif #ifndef PETSC_HAVE_FORTRAN_TYPE_STAR #define PETSC_HAVE_FORTRAN_TYPE_STAR 1 #endif #ifndef PETSC_CXX_RESTRICT #define PETSC_CXX_RESTRICT __restrict #endif #ifndef PETSC_CXX_STATIC_INLINE #define PETSC_CXX_STATIC_INLINE static inline #endif #ifndef PETSC_HAVE_LIBWS2_32 #define PETSC_HAVE_LIBWS2_32 1 #endif #ifndef PETSC_HAVE_LIBMKL_CORE_DLL #define PETSC_HAVE_LIBMKL_CORE_DLL 1 #endif #ifndef PETSC_HAVE_LIBMKL_INTEL_THREAD_DLL #define PETSC_HAVE_LIBMKL_INTEL_THREAD_DLL 1 #endif #ifndef PETSC_HAVE_LIBIMPI #define PETSC_HAVE_LIBIMPI 1 #endif #ifndef PETSC_HAVE_FENV_H #define PETSC_HAVE_FENV_H 1 #endif #ifndef PETSC_HAVE_LIBMKL_INTEL_LP64_DLL #define PETSC_HAVE_LIBMKL_INTEL_LP64_DLL 1 #endif #ifndef PETSC_HAVE_LOG2 #define PETSC_HAVE_LOG2 1 #endif #ifndef PETSC_HAVE_LIBIOMP5MD #define PETSC_HAVE_LIBIOMP5MD 1 #endif #ifndef PETSC_HAVE_ERF #define PETSC_HAVE_ERF 1 #endif #ifndef PETSC_HAVE_TGAMMA #define PETSC_HAVE_TGAMMA 1 #endif #ifndef PETSC_USE_SCALAR_REAL #define PETSC_USE_SCALAR_REAL 1 #endif #ifndef PETSC_HAVE_ISNAN #define PETSC_HAVE_ISNAN 1 #endif #ifndef PETSC_HAVE_ISNORMAL #define PETSC_HAVE_ISNORMAL 1 #endif #ifndef PETSC_HAVE__ISNAN #define PETSC_HAVE__ISNAN 1 #endif #ifndef PETSC_HAVE__FINITE #define PETSC_HAVE__FINITE 1 #endif #ifndef PETSC_USE_REAL_DOUBLE #define PETSC_USE_REAL_DOUBLE 1 #endif #ifndef PETSC_HAVE_ISINF #define PETSC_HAVE_ISINF 1 #endif #ifndef PETSC_SIZEOF_MPI_COMM #define PETSC_SIZEOF_MPI_COMM 4 #endif #ifndef PETSC_BITS_PER_BYTE #define PETSC_BITS_PER_BYTE 8 #endif #ifndef PETSC_SIZEOF_MPI_FINT #define PETSC_SIZEOF_MPI_FINT 4 #endif #ifndef PETSC_SIZEOF_VOID_P #define PETSC_SIZEOF_VOID_P 8 #endif #ifndef PETSC_RETSIGTYPE #define PETSC_RETSIGTYPE void #endif #ifndef PETSC_HAVE___INT64 #define PETSC_HAVE___INT64 1 #endif #ifndef PETSC_HAVE_CXX_COMPLEX #define PETSC_HAVE_CXX_COMPLEX 1 #endif #ifndef PETSC_SIZEOF_LONG #define PETSC_SIZEOF_LONG 4 #endif #ifndef PETSC_USE_FORTRANKIND #define PETSC_USE_FORTRANKIND 1 #endif #ifndef PETSC_SIZEOF_INT #define PETSC_SIZEOF_INT 4 #endif #ifndef PETSC_SIZEOF_SIZE_T #define PETSC_SIZEOF_SIZE_T 8 #endif #ifndef PETSC_uid_t #define PETSC_uid_t int #endif #ifndef PETSC_SIZEOF_CHAR #define PETSC_SIZEOF_CHAR 1 #endif #ifndef PETSC_SIZEOF_DOUBLE #define PETSC_SIZEOF_DOUBLE 8 #endif #ifndef PETSC_SIZEOF_FLOAT #define PETSC_SIZEOF_FLOAT 4 #endif #ifndef PETSC_gid_t #define PETSC_gid_t int #endif #ifndef PETSC_SIZEOF_LONG_LONG #define PETSC_SIZEOF_LONG_LONG 8 #endif #ifndef PETSC_SIZEOF_SHORT #define PETSC_SIZEOF_SHORT 2 #endif #ifndef PETSC_CLANGUAGE_C #define PETSC_CLANGUAGE_C 1 #endif #ifndef PETSC_USE_ERRORCHECKING #define PETSC_USE_ERRORCHECKING 1 #endif #ifndef PETSC_HAVE_ACCESS #define PETSC_HAVE_ACCESS 1 #endif #ifndef PETSC_HAVE_SIGNAL #define PETSC_HAVE_SIGNAL 1 #endif #ifndef PETSC_HAVE__MKDIR #define PETSC_HAVE__MKDIR 1 #endif #ifndef PETSC_HAVE__LSEEK #define PETSC_HAVE__LSEEK 1 #endif #ifndef PETSC_HAVE__GETCWD #define PETSC_HAVE__GETCWD 1 #endif #ifndef PETSC_HAVE_MEMMOVE #define PETSC_HAVE_MEMMOVE 1 #endif #ifndef PETSC_HAVE_RAND #define PETSC_HAVE_RAND 1 #endif #ifndef PETSC_HAVE__SLEEP #define PETSC_HAVE__SLEEP 1 #endif #ifndef PETSC_HAVE_TIME #define PETSC_HAVE_TIME 1 #endif #ifndef PETSC_HAVE_GETCWD #define PETSC_HAVE_GETCWD 1 #endif #ifndef PETSC_HAVE_LSEEK #define PETSC_HAVE_LSEEK 1 #endif #ifndef PETSC_HAVE__VSNPRINTF #define PETSC_HAVE__VSNPRINTF 1 #endif #ifndef PETSC_HAVE__ACCESS #define PETSC_HAVE__ACCESS 1 #endif #ifndef PETSC_HAVE_STRICMP #define PETSC_HAVE_STRICMP 1 #endif #ifndef PETSC_SIGNAL_CAST #define PETSC_SIGNAL_CAST #endif #ifndef PETSC_HAVE_VA_COPY #define PETSC_HAVE_VA_COPY 1 #endif #ifndef PETSC_HAVE_CLOCK #define PETSC_HAVE_CLOCK 1 #endif #ifndef PETSC_CPU_RELAX #define PETSC_CPU_RELAX() __asm__ __volatile__ ("":::"memory") #endif #ifndef PETSC_HAVE_SHARED_LIBRARIES #define PETSC_HAVE_SHARED_LIBRARIES 1 #endif #ifndef PETSC_USE_GDB_DEBUGGER #define PETSC_USE_GDB_DEBUGGER 1 #endif #ifndef PETSC_BLASLAPACK_CAPS #define PETSC_BLASLAPACK_CAPS 1 #endif #ifndef PETSC_HAVE_MKL #define PETSC_HAVE_MKL 1 #endif #ifndef PETSC_HAVE_MPI_F90MODULE #define PETSC_HAVE_MPI_F90MODULE 1 #endif #ifndef PETSC_HAVE_MPI_WIN_CREATE_FEATURE #define PETSC_HAVE_MPI_WIN_CREATE_FEATURE 1 #endif #ifndef PETSC_HAVE_MPI_IALLREDUCE #define PETSC_HAVE_MPI_IALLREDUCE 1 #endif #ifndef PETSC_HAVE_I_MPI_NUMVERSION #define PETSC_HAVE_I_MPI_NUMVERSION 0 #endif #ifndef PETSC_HAVE_MPI_REDUCE_SCATTER_BLOCK #define PETSC_HAVE_MPI_REDUCE_SCATTER_BLOCK 1 #endif #ifndef PETSC_HAVE_MPI_IN_PLACE #define PETSC_HAVE_MPI_IN_PLACE 1 #endif #ifndef PETSC_HAVE_MPI_COMM_C2F #define PETSC_HAVE_MPI_COMM_C2F 1 #endif #ifndef PETSC_HAVE_MPI_GET_LIBRARY_VERSION #define PETSC_HAVE_MPI_GET_LIBRARY_VERSION 1 #endif #ifndef PETSC_HAVE_MPI_SHARED_COMM #define PETSC_HAVE_MPI_SHARED_COMM 1 #endif #ifndef PETSC_HAVE_MPI_INT64_T #define PETSC_HAVE_MPI_INT64_T 1 #endif #ifndef PETSC_HAVE_MPI_TYPE_GET_EXTENT #define PETSC_HAVE_MPI_TYPE_GET_EXTENT 1 #endif #ifndef PETSC_HAVE_MPI_WIN_CREATE #define PETSC_HAVE_MPI_WIN_CREATE 1 #endif #ifndef PETSC_HAVE_MPIIO #define PETSC_HAVE_MPIIO 1 #endif #ifndef PETSC_HAVE_MPI_INIT_THREAD #define PETSC_HAVE_MPI_INIT_THREAD 1 #endif #ifndef PETSC_HAVE_MPI_COMBINER_NAMED #define PETSC_HAVE_MPI_COMBINER_NAMED 1 #endif #ifndef PETSC_HAVE_MPI_LONG_DOUBLE #define PETSC_HAVE_MPI_LONG_DOUBLE 1 #endif #ifndef PETSC_HAVE_MPI_COMM_F2C #define PETSC_HAVE_MPI_COMM_F2C 1 #endif #ifndef PETSC_HAVE_MPI_TYPE_GET_ENVELOPE #define PETSC_HAVE_MPI_TYPE_GET_ENVELOPE 1 #endif #ifndef PETSC_HAVE_MPI_REDUCE_SCATTER #define PETSC_HAVE_MPI_REDUCE_SCATTER 1 #endif #ifndef PETSC_HAVE_MPI_COMBINER_DUP #define PETSC_HAVE_MPI_COMBINER_DUP 1 #endif #ifndef PETSC_HAVE_MPI_TYPE_DUP #define PETSC_HAVE_MPI_TYPE_DUP 1 #endif #ifndef PETSC_HAVE_MPI_COMM_SPAWN #define PETSC_HAVE_MPI_COMM_SPAWN 1 #endif #ifndef PETSC_HAVE_MPI_FINT #define PETSC_HAVE_MPI_FINT 1 #endif #ifndef PETSC_HAVE_MPI_IBARRIER #define PETSC_HAVE_MPI_IBARRIER 1 #endif #ifndef PETSC_HAVE_MPI_ALLTOALLW #define PETSC_HAVE_MPI_ALLTOALLW 1 #endif #ifndef PETSC_HAVE_MPI_COMBINER_CONTIGUOUS #define PETSC_HAVE_MPI_COMBINER_CONTIGUOUS 1 #endif #ifndef PETSC_HAVE_MPI_WIN_SHARED_QUERY #define PETSC_HAVE_MPI_WIN_SHARED_QUERY 1 #endif #ifndef PETSC_HAVE_MPI_REDUCE_LOCAL #define PETSC_HAVE_MPI_REDUCE_LOCAL 1 #endif #ifndef PETSC_HAVE_MPI_REPLACE #define PETSC_HAVE_MPI_REPLACE 1 #endif #ifndef PETSC_HAVE_MPI_EXSCAN #define PETSC_HAVE_MPI_EXSCAN 1 #endif #ifndef PETSC_HAVE_MPI_C_DOUBLE_COMPLEX #define PETSC_HAVE_MPI_C_DOUBLE_COMPLEX 1 #endif #ifndef PETSC_HAVE_MPI_FINALIZED #define PETSC_HAVE_MPI_FINALIZED 1 #endif #ifndef PETSC_HAVE_MPI_WIN_ALLOCATE_SHARED #define PETSC_HAVE_MPI_WIN_ALLOCATE_SHARED 1 #endif #ifndef PETSC_USE_INFO #define PETSC_USE_INFO 1 #endif #ifndef PETSC_Alignx #define PETSC_Alignx(a,b) #endif #ifndef PETSC_USE_BACKWARD_LOOP #define PETSC_USE_BACKWARD_LOOP 1 #endif #ifndef PETSC_USE_MALLOC_COALESCED #define PETSC_USE_MALLOC_COALESCED 1 #endif #ifndef PETSC_USE_LOG #define PETSC_USE_LOG 1 #endif #ifndef PETSC_IS_COLOR_VALUE_TYPE_F #define PETSC_IS_COLOR_VALUE_TYPE_F integer2 #endif #ifndef PETSC_IS_COLOR_VALUE_TYPE #define PETSC_IS_COLOR_VALUE_TYPE short #endif #ifndef PETSC_USE_CTABLE #define PETSC_USE_CTABLE 1 #endif #ifndef PETSC_MEMALIGN #define PETSC_MEMALIGN 16 #endif #ifndef PETSC_LEVEL1_DCACHE_LINESIZE #define PETSC_LEVEL1_DCACHE_LINESIZE 32 #endif #ifndef PETSC_LEVEL1_DCACHE_SIZE #define PETSC_LEVEL1_DCACHE_SIZE 32768 #endif #ifndef PETSC_LEVEL1_DCACHE_ASSOC #define PETSC_LEVEL1_DCACHE_ASSOC 2 #endif #ifndef PETSC__BSD_SOURCE #define PETSC__BSD_SOURCE 1 #endif #ifndef PETSC__DEFAULT_SOURCE #define PETSC__DEFAULT_SOURCE 1 #endif #ifndef PETSC_HAVE_FORTRAN_GET_COMMAND_ARGUMENT #define PETSC_HAVE_FORTRAN_GET_COMMAND_ARGUMENT 1 #endif #ifndef PETSC_USE_PROC_FOR_SIZE #define PETSC_USE_PROC_FOR_SIZE 1 #endif #ifndef PETSC_MISSING_SIGUSR2 #define PETSC_MISSING_SIGUSR2 1 #endif #ifndef PETSC_MISSING_SIGURG #define PETSC_MISSING_SIGURG 1 #endif #ifndef PETSC_MISSING_SIGPIPE #define PETSC_MISSING_SIGPIPE 1 #endif #ifndef PETSC_MISSING_SIGHUP #define PETSC_MISSING_SIGHUP 1 #endif #ifndef PETSC_MISSING_SIGSTOP #define PETSC_MISSING_SIGSTOP 1 #endif #ifndef PETSC_MISSING_SIGSYS #define PETSC_MISSING_SIGSYS 1 #endif #ifndef PETSC_MISSING_SIGCONT #define PETSC_MISSING_SIGCONT 1 #endif #ifndef PETSC_HAVE_WSAGETLASTERROR #define PETSC_HAVE_WSAGETLASTERROR 1 #endif #ifndef PETSC_HAVE_CLOSESOCKET #define PETSC_HAVE_CLOSESOCKET 1 #endif #ifndef PETSC_MISSING_SIGTSTP #define PETSC_MISSING_SIGTSTP 1 #endif #ifndef PETSC_MISSING_SIGCHLD #define PETSC_MISSING_SIGCHLD 1 #endif #ifndef PETSC_HAVE_SOCKET #define PETSC_HAVE_SOCKET 1 #endif #ifndef PETSC_MISSING_SIGUSR1 #define PETSC_MISSING_SIGUSR1 1 #endif #ifndef PETSC_MISSING_SIGTRAP #define PETSC_MISSING_SIGTRAP 1 #endif #ifndef PETSC_MISSING_SIGQUIT #define PETSC_MISSING_SIGQUIT 1 #endif #ifndef PETSC_MISSING_SIGBUS #define PETSC_MISSING_SIGBUS 1 #endif #ifndef PETSC_HAVE_WINSOCK2_H #define PETSC_HAVE_WINSOCK2_H 1 #endif #ifndef PETSC_MISSING_SIGALRM #define PETSC_MISSING_SIGALRM 1 #endif #ifndef PETSC_NEEDS_UTYPE_TYPEDEFS #define PETSC_NEEDS_UTYPE_TYPEDEFS 1 #endif #ifndef PETSC_MISSING_SIGKILL #define PETSC_MISSING_SIGKILL 1 #endif #ifndef PETSC_MKL_SUPPORTS_BAIJ_ZERO_BASED #define PETSC_MKL_SUPPORTS_BAIJ_ZERO_BASED 1 #endif #endif **** C specific Configure header /cygdrive/c/Users/AliReza/AppData/Local/Temp/petsc-fh63UE/conffix.h **** #if !defined(INCLUDED_UNKNOWN) #define INCLUDED_UNKNOWN typedef int int32_t; typedef int mode_t; typedef int pid_t; #if defined(__cplusplus) extern "C" { #include int getdomainname(char *, size_t); double drand48(void); void srand48(long int); } #else #include int getdomainname(char *, size_t); double drand48(void); void srand48(long int); #endif #endif ******************************************************************************* UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log for details): ------------------------------------------------------------------------------- Error running configure on ML: Could not execute "cd /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml && ./configure --prefix=/home/alireza/Petsc393Install MAKE=/usr/bin/make --libdir=/home/alireza/Petsc393Install/lib CC="/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" CFLAGS="-O2 -MT -wd4996 -Qopenmp" AR="/usr/bin/ar" ARFLAGS="cr" CXX="/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl" CXXFLAGS="-O2 -MT -wd4996 -Qopenmp -TP" F90="/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort" F90FLAGS="-MT -O2 -Qopenmp -fpp" F77="/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort" FFLAGS="-MT -O2 -Qopenmp -fpp" FC="/home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort" FCFLAGS="-MT -O2 -Qopenmp -fpp" --disable-shared --disable-ml-epetra --disable-ml-aztecoo --disable-ml-examples --disable-tests --enable-libcheck --with-cflags="-O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include" CPPFLAGS="-I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include" --with-fflags="-MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include" --with-cxxflags="-O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include" --enable-mpi --with-mpi-libs="/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib" --with-blas="/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_intel_lp64_dll.lib mkl_intel_thread_dll.lib mkl_core_dll.lib libiomp5md.lib"": ---------------------------------------- Running ML Configure Script ---------------------------------------- checking whether to enable maintainer-specific portions of Makefiles... no checking build system type... x86_64-unknown-cygwin checking host system type... x86_64-unknown-cygwin checking target system type... x86_64-unknown-cygwin checking for a BSD-compatible install... /usr/bin/install -c checking whether build environment is sane... yes checking for a thread-safe mkdir -p... /usr/bin/mkdir -p checking for gawk... gawk checking whether /usr/bin/make sets $(MAKE)... yes checking whether /usr/bin/make supports nested variables... yes checking whether UID '197608' is supported by ustar format... yes checking whether GID '197121' is supported by ustar format... yes checking how to create a ustar tar archive... gnutar checking user-defined MPI libraries... /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib checking whether we are using MPI... yes checking whether the C++ compiler works... yes checking for C++ compiler default output file name... conftest.exe checking for suffix of executables... .exe checking whether we are cross compiling... no checking for suffix of object files... o checking whether we are using the GNU C++ compiler... no checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl accepts -g... yes checking for style of include used by /usr/bin/make... GNU checking dependency style of /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl... msvc7 checking whether we are using the GNU C compiler... no checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl accepts -g... yes checking for /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl option to accept ISO C89... none needed checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl understands -c and -o together... yes checking dependency style of /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl... msvc7 checking whether we are using the GNU Fortran 77 compiler... no checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort accepts -g... yes checking for ranlib... ranlib checking finding build directory... /home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml checking whether additional CCFLAGS flags should be added... no checking whether additional CXXFLAGS flags should be added... CXXFLAGS = -O2 -MT -wd4996 -Qopenmp -TP -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp -TP checking whether additional CFLAGS flags should be added... CFLAGS = -O2 -MT -wd4996 -Qopenmp -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -O2 -MT -wd4996 -Qopenmp checking whether additional FFLAGS flags should be added... FFLAGS = -MT -O2 -Qopenmp -fpp -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include -MT -O2 -Qopenmp -fpp checking whether additional libraries are needed... no checking whether additional LDFLAGS flags should be added... no checking for special archiver command... none checking how to run the C++ preprocessor... /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -E checking for mpi.h... yes checking whether to build export makefiles... yes checking for perl... yes checking whether gnumake specific code should be enabled... no checking for grep that handles long lines and -e... /usr/bin/grep checking for egrep... /usr/bin/grep -E checking for ANSI C header files... yes checking for sys/types.h... yes checking for sys/stat.h... yes checking for stdlib.h... yes checking for string.h... yes checking for memory.h... yes checking for strings.h... no checking for inttypes.h... yes checking for stdint.h... yes checking for unistd.h... no checking cstdlib usability... yes checking cstdlib presence... yes checking for cstdlib... yes checking cstdio usability... yes checking cstdio presence... yes checking for cstdio... yes checking cassert usability... yes checking cassert presence... yes checking for cassert... yes checking cmath usability... yes checking cmath presence... yes checking for cmath... yes checking iomanip usability... yes checking iomanip presence... yes checking for iomanip... yes checking iostream usability... yes checking iostream presence... yes checking for iostream... yes checking string usability... yes checking string presence... yes checking for string... yes checking malloc.h usability... yes checking malloc.h presence... yes checking for malloc.h... yes checking for inline... inline checking whether the compiler implements namespaces... yes checking whether the compiler supports Standard Template Library... yes checking whether the compiler recognizes bool as a built-in type... yes checking whether the compiler supports the mutable keyword... yes checking whether the compiler accepts the new for scoping rules... yes checking whether the compiler recognizes std::sprintf as supported IO function... yes checking whether /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl recognizes __PRETTY_FUNCTION__... yes checking whether to use ml_newtpe... yes checking whether to use ml_enrich... no checking whether to use ml_aztec2_1... no checking whether to use ml_complex_maxwell... no checking whether to use ml_timing... no checking whether to use ml_memory_checking... no checking whether to use ml_flops... no checking whether to use ml_benchmarking... no checking whether to use ml_superlu... no checking whether to use ml_superlu2... no checking whether to use ml_superlu_dist... no checking whether to use ml_metis... no checking whether to use ml_parmetis2x... no checking whether to use ml_parmetis3x... no checking whether to use ml_arpack... no checking whether to use ml_parpack... no checking whether to use ml_parasails... no checking whether to use ml_nox... no checking whether to use ml_zoltan... no checking whether to use ml_zoltan3... no checking whether to use petsc... no checking whether to build optional epetra dependent code in ml... no checking whether to build optional amesos dependent code in ml... no checking whether to build optional ifpack dependent code in ml... no checking whether to build optional teuchos dependent code in ml... no checking whether to build optional aztecoo dependent code in ml... no checking whether to build optional epetraext dependent code in ml... no checking whether to build optional isorropia dependent code in ml... no checking whether to build optional galeri dependent code in ml... no checking whether to use ml-examples... no checking whether to use tests... no checking whether to use ml-tests... no checking whether to use libcheck... yes checking whether additional library search paths defined... no checking whether additional include search paths defined... no checking how to get verbose linking output from /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort... --verbose checking for Fortran 77 libraries of /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort... -link checking for dummy main to link with Fortran 77 libraries... unknownconfigure: WARNING: unrecognized options: --disable-shared configure: error: in `/home/alireza/petsc-3.9.3/arch-mswin-c-opt/externalpackages/git.ml': configure: error: linking to Fortran libraries from C fails See `config.log' for more details ******************************************************************************* File "./config/configure.py", line 394, in petsc_configure framework.configure(out = sys.stdout) File "/home/alireza/petsc-3.9.3/config/BuildSystem/config/framework.py", line 1092, in configure self.processChildren() File "/home/alireza/petsc-3.9.3/config/BuildSystem/config/framework.py", line 1081, in processChildren self.serialEvaluation(self.childGraph) File "/home/alireza/petsc-3.9.3/config/BuildSystem/config/framework.py", line 1062, in serialEvaluation child.configure() File "/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py", line 864, in configure self.executeTest(self.configureLibrary) File "/home/alireza/petsc-3.9.3/config/BuildSystem/config/base.py", line 127, in executeTest ret = test(*args,**kargs) File "/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py", line 753, in configureLibrary for location, directory, lib, incl in self.generateGuesses(): File "/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py", line 355, in generateGuesses d = self.checkDownload() File "/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py", line 481, in checkDownload return self.getInstallDir() File "/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py", line 304, in getInstallDir installDir = self.Install() File "/home/alireza/petsc-3.9.3/config/BuildSystem/config/package.py", line 1326, in Install raise RuntimeError('Error running configure on ' + self.PACKAGE+': '+str(e)) ================================================================================ Finishing configure run at Thu, 16 Aug 2018 11:22:39 +0430 ================================================================================ From mfadams at lbl.gov Thu Aug 16 12:33:21 2018 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 16 Aug 2018 13:33:21 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: On Thu, Aug 16, 2018 at 12:20 PM Josh L wrote: > > > > 2018-08-16 10:39 GMT-05:00 Mark Adams : > > Hi Mark, > > The problem I am running is simply 2-D linear elasticity, and I use > petsc's ex49 of KSP to do benchmark. > > I have solved the error by using MatZeroRowsColumns(diagonal =1.0) to > apply BC instead of MatZeroRows. > (My code is actually using newton's method to solve nonlinear problem(Now, > use it to run a linear elasticity problem), and the rhs entries for > Dirichlet BC is just zero, so either zerorowscolumns or zerorows gives the > same solution). > > With GMRES and gamg, the 120K degrees of freedoms linear elasticity > problem converges in 7 iterations. > But with " -ksp_type chebyshev -ksp_chebyshev_esteig_noisy" I still get > NAN residual that comes out of nowhere (it is not diverging. all of a > sudden NAN shows up) > You want to use CG as the ksp type if it is symmetric (and positive definite). I would guess you don't need to zero columns but go ahead and do it, if it is easy. I am confused. I thought you were using '-ksp_type chebyshev' to debug Cheby errors when using GAMG. Anyway, with -ksp_type chebyshev you want to use CG in the eigen estimator. CG is much faster than GAMG. So you should use '-ksp_chebyshev_esteig_ksp_type cg'. And use -options_left to make sure that these parameters are getting in correctly. And you should use '-ksp_type cg'. -------------- next part -------------- An HTML attachment was scrubbed... URL: From mfadams at lbl.gov Thu Aug 16 12:36:21 2018 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 16 Aug 2018 13:36:21 -0400 Subject: [petsc-users] large number of iteration. In-Reply-To: References: <60FA7ABA-A15F-4248-AE17-7A7CBB465917@anl.gov> <2E190AB5-68EC-4A11-A3CA-1F5C5C550AD9@mcs.anl.gov> <0048DC2D-4772-4FED-A3D8-B858EFBB425E@mcs.anl.gov> <4AB6AD0A-58E1-436C-B925-CE505067B0D2@mcs.anl.gov> <84647BDF-3870-4362-B972-BC0983EE5990@mcs.anl.gov> Message-ID: Correction: CG converges to the highest eigenvalue much faster than GMRES. On Thu, Aug 16, 2018 at 1:33 PM Mark Adams wrote: > > > On Thu, Aug 16, 2018 at 12:20 PM Josh L wrote: > >> >> >> >> 2018-08-16 10:39 GMT-05:00 Mark Adams : >> >> Hi Mark, >> >> The problem I am running is simply 2-D linear elasticity, and I use >> petsc's ex49 of KSP to do benchmark. >> >> I have solved the error by using MatZeroRowsColumns(diagonal =1.0) to >> apply BC instead of MatZeroRows. >> (My code is actually using newton's method to solve nonlinear >> problem(Now, use it to run a linear elasticity problem), and the rhs >> entries for Dirichlet BC is just zero, so either zerorowscolumns or >> zerorows gives the same solution). >> >> With GMRES and gamg, the 120K degrees of freedoms linear elasticity >> problem converges in 7 iterations. >> But with " -ksp_type chebyshev -ksp_chebyshev_esteig_noisy" I still get >> NAN residual that comes out of nowhere (it is not diverging. all of a >> sudden NAN shows up) >> > > You want to use CG as the ksp type if it is symmetric (and positive > definite). I would guess you don't need to zero columns but go ahead and do > it, if it is easy. > > I am confused. I thought you were using '-ksp_type chebyshev' to debug > Cheby errors when using GAMG. > > Anyway, with -ksp_type chebyshev you want to use CG in the eigen > estimator. CG is much faster than GAMG. So you should use ' > -ksp_chebyshev_esteig_ksp_type cg'. And use -options_left to make sure > that these parameters are getting in correctly. > > And you should use '-ksp_type cg'. > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Thu Aug 16 12:42:23 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Thu, 16 Aug 2018 12:42:23 -0500 Subject: [petsc-users] Problem in compiling PETSc+ML In-Reply-To: <47fa292d-fccb-103a-24b1-9c6893734e82@cc.iut.ac.ir> References: <47fa292d-fccb-103a-24b1-9c6893734e82@cc.iut.ac.ir> Message-ID: Sorry - most external packages won't work with --download-pacakge option on windows [with MS/Intel compilers]. If you need ML on windows - you might have to install it separately [by checking its windows installation instructions - if they exist] And then specify it to petsc configure with --with-ml-include --with-ml-lib options. Satish On Thu, 16 Aug 2018, Ali Reza Khaz'ali wrote: > Hi, > > I have been using PETSc on a MS windows 7 x64 system with Intel MKL, MPI and > compilers without problem. For an specific problem, I had to use ML. However, > I could not compile ML with the before-mentioned toolsets.? The the log files > (PETSc and ML) are attached. Any help is much appreciated. > > > Thanks, > > Ali > > > From bsmith at mcs.anl.gov Thu Aug 16 13:20:58 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 16 Aug 2018 18:20:58 +0000 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> Message-ID: <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> Column too large: col 10980 max 124 You need to check the code that is generating the matrix entries. The matrix has 124 columns but you are attempting to put a value at column 10980 Barry > On Aug 15, 2018, at 9:44 PM, Manuel Valera wrote: > > Thanks Matthew and Barry, > > Now my code looks like: > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > call DMCreateMatrix(daDummy,A,ierr) > call MatSetFromOptions(A,ierr) > call MatSetUp(A,ierr) > [...] > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > [...] > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > And i get a different error, now is: > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Column too large: col 10980 max 124 > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 19:40:00 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in /home/valera/petsc/src/mat/impls/aij/seq/aij.c > [0]PETSC ERROR: #2 MatSetValues() line 1339 in /home/valera/petsc/src/mat/interface/matrix.c > > > Thanks again, > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. wrote: > > Should be > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > call DMCreateMatrix(daDummy,A,ierr) > > and remove the rest. You need to set the type of Mat you want the DM to return BEFORE you create the matrix. > > Barry > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera wrote: > > > > Ok thanks for clarifying that, i wasn't sure if there were different types, > > > > Here is a stripped down version of my code, it seems like the preallocation is working now since the matrix population part is working without problem, but here it is for illustration purposes: > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > call DMCreateMatrix(daDummy,A,ierr) > > call MatSetFromOptions(A,ierr) > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > call MatSetUp(A,ierr) > > [...] > > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > [...] > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > Adding the first line there did the trick, > > > > Now the problem seems to be the program is not recognizing the matrix as ViennaCL type when i try with more than one processor, i get now: > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [0]PETSC ERROR: No support for this operation for this object type > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 14:44:22 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > When running with: > > > > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley wrote: > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera wrote: > > It seems to be resumed on: I do not know how to preallocate a DM Matrix correctly. > > > > There is only one matrix type, Mat. There are no separate DM matrices. A DM can create a matrix for you > > using DMCreateMatrix(), but that is a Mat and it is preallocated correctly. I am not sure what you are doing. > > > > Thanks, > > > > Matt > > > > The interesting part is that it only breaks when i need to populate a GPU matrix from MPI, so kudos on that, but it seems i need to do better on my code to get this setup working, > > > > Any help would be appreciated, > > > > Thanks, > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley wrote: > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera wrote: > > Thanks Matthew, > > > > I try to do that when calling: > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > But i am not aware on how to do this for the DM if it needs something more specific/different, > > > > The error says that your preallocation is wrong for the values you are putting in. The DM does not control either, > > so I do not understand your email. > > > > Thanks, > > > > Matt > > > > Thanks, > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley wrote: > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera wrote: > > Hello PETSc devs, > > > > I am running into an error when trying to use the MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in one processor. The error happens when calling MatSetValues for this specific configuration. It does not occur when using MPI DMMatrix types only. > > > > The DM properly preallocates the matrix. I am assuming you do not here. > > > > Matt > > > > Any help will be appreciated, > > > > Thanks, > > > > > > > > My program call: > > > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view > > > > > > The error (repeats after each MatSetValues call): > > > > [1]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [1]PETSC ERROR: Argument out of range > > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) into matrix > > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 13:10:44 2018 > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in /home/valera/petsc/src/mat/interface/matrix.c > > > > > > My Code structure: > > > > call DMCreateMatrix(daDummy,A,ierr) > > call MatSetFromOptions(A,ierr) > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > if (numprocs > 1) then ! set matrix type parallel > > ! Get local size > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > call VecDestroy(Tmpnat,ierr) > > ! Set matrix > > #ifdef GPU > > call MatSetType(A,MATAIJVIENNACL,ierr) > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > print*,'SETTING GPU TYPES' > > #else > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > call DMSetMatType(daDummy,VECMPI,ierr) > > call MatSetType(A,MATMPIAIJ,ierr)! > > #endif > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > else ! set matrix type sequential > > #ifdef GPU > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > print*,'SETTING GPU TYPES' > > #else > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > call DMSetMatType(daDummy,VECSEQ,ierr) > > call MatSetType(A,MATSEQAIJ,ierr) > > #endif > > call MatSetUp(A,ierr) > > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > do k=zstart,zend-1 > > do j=ystart,yend-1 > > do i=xstart,xend-1 > > [..] > > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > [..] > > > > > > > > > > > > > > -- > > 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 > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > -- > > 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 > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > -- > > 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 > > > > https://www.cse.buffalo.edu/~knepley/ > > > > From arkhazali at cc.iut.ac.ir Thu Aug 16 14:29:20 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Thu, 16 Aug 2018 23:59:20 +0430 Subject: [petsc-users] Problem in compiling PETSc+ML In-Reply-To: References: <47fa292d-fccb-103a-24b1-9c6893734e82@cc.iut.ac.ir> Message-ID: Thanks a lot. In fact I had built ML from Trilinos before, and I wondered if I could use it in PETSc. Best wishes, Ali On 8/16/2018 10:12 PM, Satish Balay wrote: > Sorry - most external packages won't work with --download-pacakge > option on windows [with MS/Intel compilers]. > > If you need ML on windows - you might have to install it separately > [by checking its windows installation instructions - if they exist] > > And then specify it to petsc configure with --with-ml-include > --with-ml-lib options. > > Satish > > On Thu, 16 Aug 2018, Ali Reza Khaz'ali wrote: > >> Hi, >> >> I have been using PETSc on a MS windows 7 x64 system with Intel MKL, MPI and >> compilers without problem. For an specific problem, I had to use ML. However, >> I could not compile ML with the before-mentioned toolsets.? The the log files >> (PETSc and ML) are attached. Any help is much appreciated. >> >> >> Thanks, >> >> Ali >> >> -- Ali Reza Khaz?ali Assistant Professor of Petroleum Engineering, Department of Chemical Engineering Isfahan University of Technology Isfahan, Iran From balay at mcs.anl.gov Thu Aug 16 15:15:22 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Thu, 16 Aug 2018 15:15:22 -0500 Subject: [petsc-users] Problem in compiling PETSc+ML In-Reply-To: References: <47fa292d-fccb-103a-24b1-9c6893734e82@cc.iut.ac.ir> Message-ID: If you can built it from Trilinos - you should be able to use it from PETSc. [by specifing ml to petsc with --with-ml-include,--with-ml-lib options] This is unverified though.. Satish On Thu, 16 Aug 2018, Ali Reza Khaz'ali wrote: > Thanks a lot. In fact I had built ML from Trilinos before, and I wondered if I > could use it in PETSc. > > Best wishes, > > Ali > > > On 8/16/2018 10:12 PM, Satish Balay wrote: > > Sorry - most external packages won't work with --download-pacakge > > option on windows [with MS/Intel compilers]. > > > > If you need ML on windows - you might have to install it separately > > [by checking its windows installation instructions - if they exist] > > > > And then specify it to petsc configure with --with-ml-include > > --with-ml-lib options. > > > > Satish > > > > On Thu, 16 Aug 2018, Ali Reza Khaz'ali wrote: > > > >> Hi, > >> > >> I have been using PETSc on a MS windows 7 x64 system with Intel MKL, MPI > >> and > >> compilers without problem. For an specific problem, I had to use ML. > >> However, > >> I could not compile ML with the before-mentioned toolsets.? The the log > >> files > >> (PETSc and ML) are attached. Any help is much appreciated. > >> > >> > >> Thanks, > >> > >> Ali > >> > >> > > From balay at mcs.anl.gov Thu Aug 16 17:02:38 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Thu, 16 Aug 2018 17:02:38 -0500 Subject: [petsc-users] Problem in compiling PETSc+ML In-Reply-To: References: <47fa292d-fccb-103a-24b1-9c6893734e82@cc.iut.ac.ir> Message-ID: Here is one way to get --download-ml working. [its a bit hakey] 1. update ml.py to run configure with additional options: "--disable-libcheck FLIBS=Ws2_32.lib" diff --git a/config/BuildSystem/config/packages/ml.py b/config/BuildSystem/config/packages/ml.py index 2987cf2122..e921db0ef5 100644 --- a/config/BuildSystem/config/packages/ml.py +++ b/config/BuildSystem/config/packages/ml.py @@ -35,7 +35,7 @@ class Configure(config.package.GNUPackage): args.append('--disable-ml-aztecoo') args.append('--disable-ml-examples') args.append('--disable-tests') - args.append('--enable-libcheck') + args.append('--disable-libcheck') self.framework.pushLanguage('C') args.append('--with-cflags="'+self.removeWarningFlags(self.framework.getCompilerFlags())+' -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX '+ self.headers.toStringNoDupes(self.mpi.include)+'"') @@ -45,6 +45,7 @@ class Configure(config.package.GNUPackage): if hasattr(self.compilers, 'FC'): self.framework.pushLanguage('FC') args.append('--with-fflags="'+self.framework.getCompilerFlags()+' '+ self.headers.toStringNoDupes(self.mpi.include)+'"') + args.append('FLIBS=Ws2_32.lib') self.framework.popLanguage() else: args.append('F77=""') 2. run configure with option CPPFLAGS=-DICL [this works arround some include file issues inside ML] Here ML gets successfully built - but its built as libml.a - not libml.lib 3. copy PETSC_ARCH/lib/libml.a to PETSC_ARCH/lib/libml.lib 4. rerun previous configure command [don't forget CPPFLAGS=-DICL option] Satish On Thu, 16 Aug 2018, Satish Balay wrote: > If you can built it from Trilinos - you should be able to use it from PETSc. > [by specifing ml to petsc with --with-ml-include,--with-ml-lib options] > > This is unverified though.. > > Satish > > > On Thu, 16 Aug 2018, Ali Reza Khaz'ali wrote: > > > Thanks a lot. In fact I had built ML from Trilinos before, and I wondered if I > > could use it in PETSc. > > > > Best wishes, > > > > Ali > > > > > > On 8/16/2018 10:12 PM, Satish Balay wrote: > > > Sorry - most external packages won't work with --download-pacakge > > > option on windows [with MS/Intel compilers]. > > > > > > If you need ML on windows - you might have to install it separately > > > [by checking its windows installation instructions - if they exist] > > > > > > And then specify it to petsc configure with --with-ml-include > > > --with-ml-lib options. > > > > > > Satish > > > > > > On Thu, 16 Aug 2018, Ali Reza Khaz'ali wrote: > > > > > >> Hi, > > >> > > >> I have been using PETSc on a MS windows 7 x64 system with Intel MKL, MPI > > >> and > > >> compilers without problem. For an specific problem, I had to use ML. > > >> However, > > >> I could not compile ML with the before-mentioned toolsets.? The the log > > >> files > > >> (PETSc and ML) are attached. Any help is much appreciated. > > >> > > >> > > >> Thanks, > > >> > > >> Ali > > >> > > >> > > > > > From mfadams at lbl.gov Thu Aug 16 21:18:40 2018 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 16 Aug 2018 22:18:40 -0400 Subject: [petsc-users] make all error Message-ID: I am trying to build v3.7.5 and I am getting a funny make error. I did remove the arch directory before I configured. Configure seemed fine but make all is very messed up. -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: make.log Type: application/octet-stream Size: 15500 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: configure.log Type: application/octet-stream Size: 2773307 bytes Desc: not available URL: From jed at jedbrown.org Thu Aug 16 22:56:26 2018 From: jed at jedbrown.org (Jed Brown) Date: Thu, 16 Aug 2018 21:56:26 -0600 Subject: [petsc-users] make all error In-Reply-To: References: Message-ID: <87zhxl1w9h.fsf@jedbrown.org> Mark Adams writes: > I am trying to build v3.7.5 and I am getting a funny make error. I did > remove the arch directory before I configured. Configure seemed fine but > make all is very messed up. It looks like PETSC_RESTRICT (which will correspond to PETSC_C_RESTRICT when using the C compiler; it's defined to "restrict") worked during configure, but not during the Make. Are you sure nothing in the environment or paths changed? You could try editing petscconf.h to #define PETSC_C_RESTRICT __restrict__ in hopes that the compiler will understand that instead of the proper C99 name. But you're using GCC while passing options to configure that don't make sense. I don't know why configure is discarding those flags and carrying on. You probably want gcc-style syntax, -ffp-model=fast (this is the default with GCC, but not with Clang), -fopenmp-simd, etc. From mfadams at lbl.gov Fri Aug 17 02:48:48 2018 From: mfadams at lbl.gov (Mark Adams) Date: Fri, 17 Aug 2018 03:48:48 -0400 Subject: [petsc-users] make all error In-Reply-To: <87zhxl1w9h.fsf@jedbrown.org> References: <87zhxl1w9h.fsf@jedbrown.org> Message-ID: Oh damn, I was building GNU and forgot to switch my script back to Intel. Thanks, On Thu, Aug 16, 2018 at 11:56 PM Jed Brown wrote: > Mark Adams writes: > > > I am trying to build v3.7.5 and I am getting a funny make error. I did > > remove the arch directory before I configured. Configure seemed fine but > > make all is very messed up. > > It looks like PETSC_RESTRICT (which will correspond to PETSC_C_RESTRICT > when using the C compiler; it's defined to "restrict") worked during > configure, but not during the Make. Are you sure nothing in the > environment or paths changed? You could try editing petscconf.h to > > #define PETSC_C_RESTRICT __restrict__ > > in hopes that the compiler will understand that instead of the proper C99 > name. > > > But you're using GCC while passing options to configure that don't make > sense. I don't know why configure is discarding those flags and > carrying on. You probably want gcc-style syntax, -ffp-model=fast (this > is the default with GCC, but not with Clang), -fopenmp-simd, etc. > -------------- next part -------------- An HTML attachment was scrubbed... URL: From arkhazali at cc.iut.ac.ir Fri Aug 17 10:23:52 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Fri, 17 Aug 2018 19:53:52 +0430 Subject: [petsc-users] Problem in compiling PETSc+ML In-Reply-To: References: <47fa292d-fccb-103a-24b1-9c6893734e82@cc.iut.ac.ir> Message-ID: Thank you very much for the assistance. I have compiled ML (and HYPRE, too) separately; and then linked them to PETSc with --with-ml-include,--with-ml-lib and --with-hypre-include,--with-hypre-lib. The modules are accessible from PETSc interface now, and working as expected. Ali On 8/17/2018 2:32 AM, Satish Balay wrote: > Here is one way to get --download-ml working. [its a bit hakey] > > 1. update ml.py to run configure with additional options: "--disable-libcheck FLIBS=Ws2_32.lib" > > diff --git a/config/BuildSystem/config/packages/ml.py b/config/BuildSystem/config/packages/ml.py > index 2987cf2122..e921db0ef5 100644 > --- a/config/BuildSystem/config/packages/ml.py > +++ b/config/BuildSystem/config/packages/ml.py > @@ -35,7 +35,7 @@ class Configure(config.package.GNUPackage): > args.append('--disable-ml-aztecoo') > args.append('--disable-ml-examples') > args.append('--disable-tests') > - args.append('--enable-libcheck') > + args.append('--disable-libcheck') > > self.framework.pushLanguage('C') > args.append('--with-cflags="'+self.removeWarningFlags(self.framework.getCompilerFlags())+' -DMPICH_SKIP_MPICXX -DOMPI_SKIP_MPICXX '+ self.headers.toStringNoDupes(self.mpi.include)+'"') > @@ -45,6 +45,7 @@ class Configure(config.package.GNUPackage): > if hasattr(self.compilers, 'FC'): > self.framework.pushLanguage('FC') > args.append('--with-fflags="'+self.framework.getCompilerFlags()+' '+ self.headers.toStringNoDupes(self.mpi.include)+'"') > + args.append('FLIBS=Ws2_32.lib') > self.framework.popLanguage() > else: > args.append('F77=""') > > 2. run configure with option CPPFLAGS=-DICL [this works arround some include file issues inside ML] > > Here ML gets successfully built - but its built as libml.a - not libml.lib > > 3. copy PETSC_ARCH/lib/libml.a to PETSC_ARCH/lib/libml.lib > > 4. rerun previous configure command [don't forget CPPFLAGS=-DICL option] > > Satish > > On Thu, 16 Aug 2018, Satish Balay wrote: > >> If you can built it from Trilinos - you should be able to use it from PETSc. >> [by specifing ml to petsc with --with-ml-include,--with-ml-lib options] >> >> This is unverified though.. >> >> Satish >> >> >> On Thu, 16 Aug 2018, Ali Reza Khaz'ali wrote: >> >>> Thanks a lot. In fact I had built ML from Trilinos before, and I wondered if I >>> could use it in PETSc. >>> >>> Best wishes, >>> >>> Ali >>> >>> >>> On 8/16/2018 10:12 PM, Satish Balay wrote: >>>> Sorry - most external packages won't work with --download-pacakge >>>> option on windows [with MS/Intel compilers]. >>>> >>>> If you need ML on windows - you might have to install it separately >>>> [by checking its windows installation instructions - if they exist] >>>> >>>> And then specify it to petsc configure with --with-ml-include >>>> --with-ml-lib options. >>>> >>>> Satish >>>> >>>> On Thu, 16 Aug 2018, Ali Reza Khaz'ali wrote: >>>> >>>>> Hi, >>>>> >>>>> I have been using PETSc on a MS windows 7 x64 system with Intel MKL, MPI >>>>> and >>>>> compilers without problem. For an specific problem, I had to use ML. >>>>> However, >>>>> I could not compile ML with the before-mentioned toolsets.? The the log >>>>> files >>>>> (PETSc and ML) are attached. Any help is much appreciated. >>>>> >>>>> >>>>> Thanks, >>>>> >>>>> Ali >>>>> >>>>> >>> -- Ali Reza Khaz?ali Assistant Professor of Petroleum Engineering, Department of Chemical Engineering Isfahan University of Technology Isfahan, Iran From dnpham at wpi.edu Fri Aug 17 14:45:44 2018 From: dnpham at wpi.edu (Pham, Dung Ngoc) Date: Fri, 17 Aug 2018 19:45:44 +0000 Subject: [petsc-users] Implementing checkpoints in matrix construction Message-ID: Dear Petsc developers and Users, I am constructing a very large matrices (~5,000,000*5,000,000) for a generalized eigenvalue problem in MPIAIJ format across multiple nodes. The program is to be run on a shared HPC cluster using Slurm workload manager. Due to multiple loops and calculations needed, the matrix construction time is long (may span for more than a week). Hence, I am trying to see if I can implement checkpoints into the codes, so that the matrix can be constructed partially through multiple job submissions, each job picking up from where the previous one left until the matrix is fully built and we can write the global matrix into a binary file for further eigenvalue analysis. My questions are: Does Petsc MPIAIJ format is amenable to such check points? If so, are there any subroutines/functions that I can start with? I appreciate any comments/suggestions. Thank you, D. N. Pham -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Fri Aug 17 15:00:43 2018 From: jed at jedbrown.org (Jed Brown) Date: Fri, 17 Aug 2018 14:00:43 -0600 Subject: [petsc-users] Implementing checkpoints in matrix construction In-Reply-To: References: Message-ID: <87mutk226s.fsf@jedbrown.org> Can you split the computation into several parts such that the matrix you desire is a sum? A = A_1 + A_2 + A_3 + ... Then you can create and write each of the matrices A_i separately (perhaps in parallel jobs) and sum them later. "Pham, Dung Ngoc" writes: > Dear Petsc developers and Users, > > I am constructing a very large matrices (~5,000,000*5,000,000) for a generalized eigenvalue problem in MPIAIJ format across multiple nodes. The program is to be run on a shared HPC cluster using Slurm workload manager. Due to multiple loops and calculations needed, the matrix construction time is long (may span for more than a week). > > Hence, I am trying to see if I can implement checkpoints into the codes, so that the matrix can be constructed partially through multiple job submissions, each job picking up from where the previous one left until the matrix is fully built and we can write the global matrix into a binary file for further eigenvalue analysis. My questions are: > Does Petsc MPIAIJ format is amenable to such check points? > If so, are there any subroutines/functions that I can start with? > > I appreciate any comments/suggestions. > > Thank you, > D. N. Pham From bsmith at mcs.anl.gov Fri Aug 17 15:01:55 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Fri, 17 Aug 2018 20:01:55 +0000 Subject: [petsc-users] Implementing checkpoints in matrix construction In-Reply-To: References: Message-ID: <9CBF6097-2A10-422E-AEF9-2BA0D44445C0@anl.gov> I assume the matrix is relatively sparse? It is not even close to being amenable to this type of thing. I would simply have your program save the matrix entries to disk in some simple binary format and write another simple program that reads them in and sets them into a SeqAIJ matrix, then VecView that matrix to a binary viewer, finally have your eigenvalue code simply use VecLoad to load the matrix and start the eigen computations. Barry > On Aug 17, 2018, at 2:45 PM, Pham, Dung Ngoc wrote: > > Dear Petsc developers and Users, > > I am constructing a very large matrices (~5,000,000*5,000,000) for a generalized eigenvalue problem in MPIAIJ format across multiple nodes. The program is to be run on a shared HPC cluster using Slurm workload manager. Due to multiple loops and calculations needed, the matrix construction time is long (may span for more than a week). > > Hence, I am trying to see if I can implement checkpoints into the codes, so that the matrix can be constructed partially through multiple job submissions, each job picking up from where the previous one left until the matrix is fully built and we can write the global matrix into a binary file for further eigenvalue analysis. My questions are: > Does Petsc MPIAIJ format is amenable to such check points? > If so, are there any subroutines/functions that I can start with? > > I appreciate any comments/suggestions. > > Thank you, > D. N. Pham From knepley at gmail.com Fri Aug 17 15:16:09 2018 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 17 Aug 2018 16:16:09 -0400 Subject: [petsc-users] Implementing checkpoints in matrix construction In-Reply-To: <9CBF6097-2A10-422E-AEF9-2BA0D44445C0@anl.gov> References: <9CBF6097-2A10-422E-AEF9-2BA0D44445C0@anl.gov> Message-ID: On Fri, Aug 17, 2018 at 4:02 PM Smith, Barry F. wrote: > > I assume the matrix is relatively sparse? > > It is not even close to being amenable to this type of thing. > > I would simply have your program save the matrix entries to disk in > some simple binary format and write another simple program that reads them > in and sets them into a SeqAIJ matrix, It might be that his matrix is too large for the memory of one node. Is it? If so, you could use Jed's scheme for decomposing it. If that is not easy, you could do that following: 1) Preallocate the matrix 2) Fill it with zeros 3) Start calculating entries and adding them 4) At any time you can MatView() the matrix in binary format 5) You can always restart your calculations from the last MatView() just by MatLoad()ing that file Thanks, MAtt > then VecView that matrix to a binary viewer, finally have your eigenvalue > code simply use VecLoad to load the matrix and start the eigen computations. > > Barry > > > > On Aug 17, 2018, at 2:45 PM, Pham, Dung Ngoc wrote: > > > > Dear Petsc developers and Users, > > > > I am constructing a very large matrices (~5,000,000*5,000,000) for a > generalized eigenvalue problem in MPIAIJ format across multiple nodes. The > program is to be run on a shared HPC cluster using Slurm workload manager. > Due to multiple loops and calculations needed, the matrix construction time > is long (may span for more than a week). > > > > Hence, I am trying to see if I can implement checkpoints into the codes, > so that the matrix can be constructed partially through multiple job > submissions, each job picking up from where the previous one left until the > matrix is fully built and we can write the global matrix into a binary file > for further eigenvalue analysis. My questions are: > > Does Petsc MPIAIJ format is amenable to such check points? > > If so, are there any subroutines/functions that I can start with? > > > > I appreciate any comments/suggestions. > > > > Thank you, > > D. N. Pham > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From mhbaghaei at mail.sjtu.edu.cn Fri Aug 17 23:56:32 2018 From: mhbaghaei at mail.sjtu.edu.cn (Amir) Date: Sat, 18 Aug 2018 12:56:32 +0800 Subject: [petsc-users] Setting SNESVI Message-ID: <1534566770.local-ad07529d-23c1-v1.4.2-f587b7b7@getmailspring.com> Hi I need to apply constraint to primitive variables. I am troubling to set up SNESVI. After running the code, I feel SNES is not actually solving. After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in function norm. I think the way I set VI maybe wrong. Sorry for my simple explanation. Very thankful for your time. Amir SNESCreate(PETSC_COMM_WORLD,&snes); SNESSetApplicationContext(snes,&user); SNESSetDM(snes,user.dm); SNESSetFunction(snes,NULL,FormFunction,&user); FormInitialSolution(user.X,&user); SNESSetSolution(snes,user.X); SNESMonitorSet(snes,MySNESMonitor,&user,NULL); SNESSetType(snes,SNESVINEWTONSSLS); SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); SNESGetLineSearch(snes,&linesearch); SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); SNESSetFromOptions(snes); SNESSolve(snes,NULL,user.X); -------------- next part -------------- An HTML attachment was scrubbed... URL: From jychang48 at gmail.com Fri Aug 17 23:59:17 2018 From: jychang48 at gmail.com (Justin Chang) Date: Fri, 17 Aug 2018 22:59:17 -0600 Subject: [petsc-users] Setting SNESVI In-Reply-To: <1534566770.local-ad07529d-23c1-v1.4.2-f587b7b7@getmailspring.com> References: <1534566770.local-ad07529d-23c1-v1.4.2-f587b7b7@getmailspring.com> Message-ID: Have you tried SNESVINEWTONRSLS? In my experience, I seem to have slightly better luck with that one instead of SNESVINEWTONSSLS On Sat, Aug 18, 2018 at 12:56 AM Amir wrote: > Hi > I need to apply constraint to primitive variables. I am troubling to set > up SNESVI. After running the code, I feel SNES is not actually solving. > After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in > function norm. > I think the way I set VI maybe wrong. Sorry for my simple explanation. > Very thankful for your time. > Amir > SNESCreate(PETSC_COMM_WORLD,&snes); > SNESSetApplicationContext(snes,&user); > SNESSetDM(snes,user.dm); > SNESSetFunction(snes,NULL,FormFunction,&user); > FormInitialSolution(user.X,&user); > SNESSetSolution(snes,user.X); > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > SNESSetType(snes,SNESVINEWTONSSLS); > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > SNESGetLineSearch(snes,&linesearch); > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > SNESSetFromOptions(snes); > SNESSolve(snes,NULL,user.X); > [image: Open Tracking] -------------- next part -------------- An HTML attachment was scrubbed... URL: From mhbaghaei at mail.sjtu.edu.cn Sat Aug 18 00:24:03 2018 From: mhbaghaei at mail.sjtu.edu.cn (Amir) Date: Sat, 18 Aug 2018 13:24:03 +0800 Subject: [petsc-users] Setting SNESVI In-Reply-To: References: Message-ID: <1534569654.local-a0d70606-12e6-v1.4.2-f587b7b7@getmailspring.com> I just tried. But it gives me same pattern. After One iteration, it diverges. I am now sure some thing is wrong with my setting. On Aug 18 2018, at 12:59 pm, Justin Chang wrote: > > Have you tried SNESVINEWTONRSLS? In my experience, I seem to have slightly better luck with that one instead of SNESVINEWTONSSLS > > On Sat, Aug 18, 2018 at 12:56 AM Amir wrote: > > Hi > > I need to apply constraint to primitive variables. I am troubling to set up SNESVI. After running the code, I feel SNES is not actually solving. After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in function norm. > > I think the way I set VI maybe wrong. Sorry for my simple explanation. > > Very thankful for your time. > > Amir > > SNESCreate(PETSC_COMM_WORLD,&snes); > > SNESSetApplicationContext(snes,&user); > > SNESSetDM(snes,user.dm (https://link.getmailspring.com/link/1534569654.local-a0d70606-12e6-v1.4.2-f587b7b7 at getmailspring.com/1?redirect=http%3A%2F%2Fuser.dm&recipient=cGV0c2MtdXNlcnNAbWNzLmFubC5nb3Y%3D)); > > SNESSetFunction(snes,NULL,FormFunction,&user); > > FormInitialSolution(user.X,&user); > > SNESSetSolution(snes,user.X); > > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > > SNESSetType(snes,SNESVINEWTONSSLS); > > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > > SNESGetLineSearch(snes,&linesearch); > > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > > SNESSetFromOptions(snes); > > SNESSolve(snes,NULL,user.X); > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Sat Aug 18 07:48:03 2018 From: knepley at gmail.com (Matthew Knepley) Date: Sat, 18 Aug 2018 08:48:03 -0400 Subject: [petsc-users] Setting SNESVI In-Reply-To: <1534569654.local-a0d70606-12e6-v1.4.2-f587b7b7@getmailspring.com> References: <1534569654.local-a0d70606-12e6-v1.4.2-f587b7b7@getmailspring.com> Message-ID: First dolve the unconstrained problem to make sure that works. Matt On Sat, Aug 18, 2018, 01:24 Amir wrote: > I just tried. But it gives me same pattern. After One iteration, it > diverges. I am now sure some thing is wrong with my setting. > > On Aug 18 2018, at 12:59 pm, Justin Chang wrote: > > > Have you tried SNESVINEWTONRSLS? In my experience, I seem to have > slightly better luck with that one instead of SNESVINEWTONSSLS > > On Sat, Aug 18, 2018 at 12:56 AM Amir > > wrote: > > Hi > I need to apply constraint to primitive variables. I am troubling to set > up SNESVI. After running the code, I feel SNES is not actually solving. > After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in > function norm. > I think the way I set VI maybe wrong. Sorry for my simple explanation. > Very thankful for your time. > Amir > SNESCreate(PETSC_COMM_WORLD,&snes); > SNESSetApplicationContext(snes,&user); > SNESSetDM(snes,user.dm > > ); > SNESSetFunction(snes,NULL,FormFunction,&user); > FormInitialSolution(user.X,&user); > SNESSetSolution(snes,user.X); > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > SNESSetType(snes,SNESVINEWTONSSLS); > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > SNESGetLineSearch(snes,&linesearch); > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > SNESSetFromOptions(snes); > SNESSolve(snes,NULL,user.X); > [image: Open Tracking] > > [image: Open Tracking] -------------- next part -------------- An HTML attachment was scrubbed... URL: From mhbaghaei at mail.sjtu.edu.cn Sat Aug 18 08:54:07 2018 From: mhbaghaei at mail.sjtu.edu.cn (Amir) Date: Sat, 18 Aug 2018 21:54:07 +0800 Subject: [petsc-users] Setting SNESVI In-Reply-To: References: Message-ID: <1534600291.local-99f6de16-0c60-v1.4.2-f587b7b7@getmailspring.com> I just comment out the SNESVISetVariableBounds and SNESLineSearchSetVIFunctions. trying to rerun the code, SNES successfully converged, with not active constraint. Amir On Aug 18 2018, at 8:48 pm, Matthew Knepley wrote: > > First dolve the unconstrained problem to make sure that works. > > Matt > On Sat, Aug 18, 2018, 01:24 Amir wrote: > > I just tried. But it gives me same pattern. After One iteration, it diverges. I am now sure some thing is wrong with my setting. > > > > On Aug 18 2018, at 12:59 pm, Justin Chang wrote: > > > > > > Have you tried SNESVINEWTONRSLS? In my experience, I seem to have slightly better luck with that one instead of SNESVINEWTONSSLS > > > > > > On Sat, Aug 18, 2018 at 12:56 AM Amir wrote: > > > > Hi > > > > I need to apply constraint to primitive variables. I am troubling to set up SNESVI. After running the code, I feel SNES is not actually solving. After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in function norm. > > > > I think the way I set VI maybe wrong. Sorry for my simple explanation. > > > > Very thankful for your time. > > > > Amir > > > > SNESCreate(PETSC_COMM_WORLD,&snes); > > > > SNESSetApplicationContext(snes,&user); > > > > SNESSetDM(snes,user.dm (https://link.getmailspring.com/link/1534600291.local-99f6de16-0c60-v1.4.2-f587b7b7 at getmailspring.com/3?redirect=https%3A%2F%2Flink.getmailspring.com%2Flink%2F1534569654.local-a0d70606-12e6-v1.4.2-f587b7b7%40getmailspring.com%2F1%3Fredirect%3Dhttp%253A%252F%252Fuser.dm%26recipient%3DcGV0c2MtdXNlcnNAbWNzLmFubC5nb3Y%253D&recipient=cGV0c2MtdXNlcnNAbWNzLmFubC5nb3Y%3D)); > > > > SNESSetFunction(snes,NULL,FormFunction,&user); > > > > FormInitialSolution(user.X,&user); > > > > SNESSetSolution(snes,user.X); > > > > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > > > > SNESSetType(snes,SNESVINEWTONSSLS); > > > > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > > > > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > > > > SNESGetLineSearch(snes,&linesearch); > > > > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > > > > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > > > > SNESSetFromOptions(snes); > > > > SNESSolve(snes,NULL,user.X); > > > > > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sat Aug 18 10:42:06 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Sat, 18 Aug 2018 15:42:06 +0000 Subject: [petsc-users] Setting SNESVI In-Reply-To: <1534566770.local-ad07529d-23c1-v1.4.2-f587b7b7@getmailspring.com> References: <1534566770.local-ad07529d-23c1-v1.4.2-f587b7b7@getmailspring.com> Message-ID: <59E591C6-5596-40DB-AB01-7C2139D0158C@anl.gov> -snes_monitor -snes_linesearch_monitor -pc_type lu produces what? Barry The line search failing means that the direction computed is not a descent direction which could be due to a bad Jacobian or inconsistent constraints. > On Aug 17, 2018, at 11:56 PM, Amir wrote: > > Hi > I need to apply constraint to primitive variables. I am troubling to set up SNESVI. After running the code, I feel SNES is not actually solving. After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in function norm. > I think the way I set VI maybe wrong. Sorry for my simple explanation. > Very thankful for your time. > Amir > SNESCreate(PETSC_COMM_WORLD,&snes); > SNESSetApplicationContext(snes,&user); > SNESSetDM(snes,user.dm); > SNESSetFunction(snes,NULL,FormFunction,&user); > FormInitialSolution(user.X,&user); > SNESSetSolution(snes,user.X); > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > SNESSetType(snes,SNESVINEWTONSSLS); > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > SNESGetLineSearch(snes,&linesearch); > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > SNESSetFromOptions(snes); > SNESSolve(snes,NULL,user.X); > From mhbaghaei at mail.sjtu.edu.cn Sun Aug 19 09:19:22 2018 From: mhbaghaei at mail.sjtu.edu.cn (Amir) Date: Sun, 19 Aug 2018 22:19:22 +0800 Subject: [petsc-users] Setting SNESVI In-Reply-To: <59E591C6-5596-40DB-AB01-7C2139D0158C@anl.gov> References: <59E591C6-5596-40DB-AB01-7C2139D0158C@anl.gov> Message-ID: <1534687923.local-d7e5039a-f013-v1.4.2-f587b7b7@getmailspring.com> This is what I get after I modify the constraints, and using lu: 0 SNES Function norm 6.839975279451e+01 0 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 1.167382139621e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.661035212791e+01 lambda=1.4620823686291085e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.872462383177e+01 lambda=1.4620823686291085e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.010735352812e+01 lambda=1.4620823686291087e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.845164828370e+01 lambda=1.4620823686291088e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 6.840024692820e+01 lambda=1.4620823686291089e-06 Line search: Cubically determined step, current gnorm 6.839974867692e+01 lambda=1.4620823686291089e-07 1 SNES Function norm 6.839974867692e+01 1 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 1 Line search: gnorm after quadratic fit 1.313376791907e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.102614855398e+02 lambda=1.4115774027030809e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 9.096517666290e+01 lambda=1.4115774027030810e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.587134084601e+01 lambda=1.4115774027030810e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.877273920434e+01 lambda=1.4115774027030810e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 6.840408582565e+01 lambda=1.4115774027030811e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 6.839977811504e+01 lambda=1.4115774027030813e-07 Line search: Cubically determined step, current gnorm 6.839974761445e+01 lambda=1.7645101306134412e-08 2 SNES Function norm 6.839974761445e+01 2 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: gnorm after quadratic fit 1.053816835919e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.064875244204e+02 lambda=2.9620424834498244e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 8.928160190384e+01 lambda=2.9620424834498247e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.462621000022e+01 lambda=2.9620424834498249e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.862607236334e+01 lambda=2.9620424834498250e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 6.840219410268e+01 lambda=2.9620424834498251e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 6.839975697009e+01 lambda=2.9620424834498251e-07 Line search: Cubically determined step, current gnorm 6.839974486019e+01 lambda=1.0073837635308560e-07 3 SNES Function norm 6.839974486019e+01 3 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: gnorm after quadratic fit 1.235990792724e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 1.013971718389e+02 lambda=2.3488863243422971e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.781731557824e+01 lambda=2.3488863243422975e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.872972483427e+01 lambda=2.3488863243422976e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.840207967049e+01 lambda=2.3488863243422978e-05 Line search: Cubically determined step, current gnorm 6.839957781288e+01 lambda=4.7431867318372446e-06 4 SNES Function norm 6.839957781288e+01 4 SNES VI Function norm 68.4009 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: gnorm after quadratic fit 1.076412782767e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 8.067259042361e+01 lambda=2.9654955573060381e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.991099677071e+01 lambda=2.9654955573060384e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.841319422751e+01 lambda=2.9654955573060385e-04 Line search: Cubically determined step, current gnorm 6.839661391957e+01 lambda=8.6072251116571315e-05 5 SNES Function norm 6.839661391957e+01 5 SNES VI Function norm 68.4308 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: gnorm after quadratic fit 9.167521781305e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 8.101349837507e+01 lambda=6.4300240519536755e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.041475585659e+01 lambda=6.6547102741568651e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.844705599568e+01 lambda=6.6547102741568653e-04 Line search: Cubically determined step, current gnorm 6.839121015135e+01 lambda=1.4965127147397144e-04 6 SNES Function norm 6.839121015135e+01 6 SNES VI Function norm 68.5745 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 3 Line search: gnorm after quadratic fit 9.587731188484e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 8.197287845440e+01 lambda=5.2775823101139679e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.940305546680e+01 lambda=5.2775823101139686e-03 Line search: Cubically determined step, current gnorm 6.837177518619e+01 lambda=6.3969948101878912e-04 7 SNES Function norm 6.837177518619e+01 7 SNES VI Function norm 71.0652 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 3 Line search: gnorm after quadratic fit 9.548865181502e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.876974019161e+01 lambda=5.0026957605696178e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.891985531663e+01 lambda=5.1260581886742491e-03 Line search: Cubically determined step, current gnorm 6.832012833110e+01 lambda=9.3300874565775075e-04 8 SNES Function norm 6.832012833110e+01 8 SNES VI Function norm 79.8569 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 4 Line search: gnorm after quadratic fit 9.541909192352e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.493349067288e+01 lambda=5.1388541796399699e-02 Line search: Cubically determined step, current gnorm 6.781311229195e+01 lambda=7.6704381452756282e-03 9 SNES Function norm 6.781311229195e+01 9 SNES VI Function norm 206.467 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 6 Line search: gnorm after quadratic fit 9.394254710662e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.306526091645e+01 lambda=5.3539445292607950e-02 Line search: Cubically determined step, current gnorm 6.721835250392e+01 lambda=9.5561464381222188e-03 10 SNES Function norm 6.721835250392e+01 10 SNES VI Function norm 368.277 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 7 Line search: gnorm after quadratic fit 9.387716261564e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.070868333837e+01 lambda=4.9443994240769853e-02 Line search: Cubically determined step, current gnorm 6.660967991379e+01 lambda=1.0810468882260445e-02 11 SNES Function norm 6.660967991379e+01 11 SNES VI Function norm 567.089 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 9 Line search: gnorm after quadratic fit 9.346306901087e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.048649174104e+01 lambda=4.9192073733008407e-02 Line search: Cubically determined step, current gnorm 6.608645472517e+01 lambda=1.0044112192046832e-02 12 SNES Function norm 6.608645472517e+01 12 SNES VI Function norm 734.752 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 8 Line search: gnorm after quadratic fit 9.452595067062e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.208837086000e+01 lambda=4.5128845776024190e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.800731174084e+01 lambda=6.5132735322282484e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.634685717588e+01 lambda=6.5132735322282484e-04 Line search: Cubically determined step, current gnorm 6.608637269301e+01 lambda=6.5132735322282487e-05 13 SNES Function norm 6.608637269301e+01 13 SNES VI Function norm 735.814 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 8 Line search: gnorm after quadratic fit 9.318693996551e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.139943393009e+01 lambda=4.8118075850982413e-02 Line search: Cubically determined step, current gnorm 6.568600823304e+01 lambda=7.8756632431255542e-03 14 SNES Function norm 6.568600823304e+01 14 SNES VI Function norm 881.479 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 9 Line search: gnorm after quadratic fit 9.242424276014e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.226307852468e+01 lambda=4.8021995541678457e-02 Line search: Cubically determined step, current gnorm 6.540144178550e+01 lambda=6.6931701304969058e-03 15 SNES Function norm 6.540144178550e+01 15 SNES VI Function norm 1006.28 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 10 Line search: gnorm after quadratic fit 9.154992244384e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.122067564574e+01 lambda=5.0277415210907568e-02 Line search: Cubically determined step, current gnorm 6.506969399500e+01 lambda=7.8660529387648906e-03 16 SNES Function norm 6.506969399500e+01 16 SNES VI Function norm 1131.4 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 10 Line search: gnorm after quadratic fit 9.263744099217e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.045825559590e+01 lambda=4.3976587783298791e-02 Line search: Cubically determined step, current gnorm 6.477740872258e+01 lambda=6.6653314620139965e-03 17 SNES Function norm 6.477740872258e+01 17 SNES VI Function norm 1252.29 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 10 Line search: gnorm after quadratic fit 9.034042193429e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.097176730586e+01 lambda=4.9082849797732621e-02 Line search: Cubically determined step, current gnorm 6.448770943479e+01 lambda=7.1730414269226593e-03 18 SNES Function norm 6.448770943479e+01 18 SNES VI Function norm 1371.72 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 10 Line search: gnorm after quadratic fit 9.028256513212e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.990381886066e+01 lambda=4.4193294185915478e-02 Line search: Cubically determined step, current gnorm 6.422123220407e+01 lambda=6.6250183714544201e-03 19 SNES Function norm 6.422123220407e+01 19 SNES VI Function norm 1490.87 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 10 Line search: gnorm after quadratic fit 8.908334154738e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.060161630260e+01 lambda=4.6452357120490895e-02 Line search: Cubically determined step, current gnorm 6.411445689017e+01 lambda=6.3417192629449783e-03 20 SNES Function norm 6.411445689017e+01 20 SNES VI Function norm 1597.29 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.460267552084e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.051195181220e+01 lambda=5.8933530173091400e-02 Line search: Cubically determined step, current gnorm 6.379276529842e+01 lambda=9.2451193719573169e-03 21 SNES Function norm 6.379276529842e+01 21 SNES VI Function norm 1729.35 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 10 Line search: gnorm after quadratic fit 8.847710713735e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.007434740347e+01 lambda=4.8620669909360585e-02 Line search: Cubically determined step, current gnorm 6.358026444281e+01 lambda=6.8922394760267177e-03 22 SNES Function norm 6.358026444281e+01 22 SNES VI Function norm 1849.77 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 10 Line search: gnorm after quadratic fit 9.435581241699e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.335475468652e+01 lambda=3.2814238215953598e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.652843583618e+01 lambda=3.2814238215953598e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.529985391051e+01 lambda=3.2814238215953602e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.366726270581e+01 lambda=3.2814238215953603e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 6.358115196460e+01 lambda=3.2814238215953603e-06 Line search: Cubically determined step, current gnorm 6.358025861312e+01 lambda=3.2814238215953605e-07 23 SNES Function norm 6.358025861312e+01 23 SNES VI Function norm 1849.78 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 10 Line search: gnorm after quadratic fit 8.812900895448e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.822426303212e+01 lambda=4.8421685266110105e-02 Line search: Cubically determined step, current gnorm 6.335842666537e+01 lambda=8.4588034499471741e-03 24 SNES Function norm 6.335842666537e+01 24 SNES VI Function norm 1993.6 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 9.094159193064e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.742173830047e+01 lambda=4.3243453252109078e-02 Line search: Cubically determined step, current gnorm 6.316236273224e+01 lambda=7.7494584282214512e-03 25 SNES Function norm 6.316236273224e+01 25 SNES VI Function norm 2126.62 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 9.160540289460e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.722886652974e+01 lambda=4.1792497999647044e-02 Line search: Cubically determined step, current gnorm 6.300020419956e+01 lambda=7.3335939016311632e-03 26 SNES Function norm 6.300020419956e+01 26 SNES VI Function norm 2252.12 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 10 Line search: gnorm after quadratic fit 8.890109786397e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.686097246249e+01 lambda=4.7041389395739201e-02 Line search: Cubically determined step, current gnorm 6.283084254493e+01 lambda=9.0792221408297433e-03 27 SNES Function norm 6.283084254493e+01 27 SNES VI Function norm 2404.84 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.998798828268e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.576469464321e+01 lambda=4.2887406731046039e-02 Line search: Cubically determined step, current gnorm 6.266968273817e+01 lambda=9.2948647727201898e-03 28 SNES Function norm 6.266968273817e+01 28 SNES VI Function norm 2558.11 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 9.199146621649e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.564298288247e+01 lambda=4.0193768728643060e-02 Line search: Cubically determined step, current gnorm 6.252861090423e+01 lambda=8.3932894622200105e-03 29 SNES Function norm 6.252861090423e+01 29 SNES VI Function norm 2698.56 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 9.382191898563e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.772162800128e+01 lambda=3.5914901407691102e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.485302824556e+01 lambda=4.7901702628153379e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.285215446174e+01 lambda=4.7901702628153379e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.253029194340e+01 lambda=4.7901702628153380e-05 Line search: Cubically determined step, current gnorm 6.252812967035e+01 lambda=1.5127710264417741e-05 30 SNES Function norm 6.252812967035e+01 30 SNES VI Function norm 2698.83 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 9.118652411357e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.495202040381e+01 lambda=4.0596953253201326e-02 Line search: Cubically determined step, current gnorm 6.239041273754e+01 lambda=9.5128837682561859e-03 31 SNES Function norm 6.239041273754e+01 31 SNES VI Function norm 2854.38 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 9.077825361440e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.467284344645e+01 lambda=4.0583557291813177e-02 Line search: Cubically determined step, current gnorm 6.225884047363e+01 lambda=9.7846838097028124e-03 32 SNES Function norm 6.225884047363e+01 32 SNES VI Function norm 3012.55 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.920999190500e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.466103609666e+01 lambda=4.2498592612658738e-02 Line search: Cubically determined step, current gnorm 6.213582712328e+01 lambda=1.0171220001350099e-02 33 SNES Function norm 6.213582712328e+01 33 SNES VI Function norm 3175.23 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 9.011924620812e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.495110751676e+01 lambda=4.2453491229013124e-02 Line search: Cubically determined step, current gnorm 6.201636649414e+01 lambda=9.3685443832871688e-03 34 SNES Function norm 6.201636649414e+01 34 SNES VI Function norm 3322.22 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 9.006024690051e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.414041989575e+01 lambda=4.0940226638739433e-02 Line search: Cubically determined step, current gnorm 6.190218472271e+01 lambda=1.0273994032172384e-02 35 SNES Function norm 6.190218472271e+01 35 SNES VI Function norm 3484.25 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.898991234613e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.426189506521e+01 lambda=4.3426020819675164e-02 Line search: Cubically determined step, current gnorm 6.178678684779e+01 lambda=1.0559984512509757e-02 36 SNES Function norm 6.178678684779e+01 36 SNES VI Function norm 3648.36 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.648025040907e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.404650680722e+01 lambda=4.6749921483990771e-02 Line search: Cubically determined step, current gnorm 6.165099494681e+01 lambda=1.1866483746353381e-02 37 SNES Function norm 6.165099494681e+01 37 SNES VI Function norm 3822.88 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.858076523292e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.520416756669e+01 lambda=4.2063577748779259e-02 Line search: Cubically determined step, current gnorm 6.152598711257e+01 lambda=7.9475995139781722e-03 38 SNES Function norm 6.152598711257e+01 38 SNES VI Function norm 3944.22 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.742192022113e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.343055909293e+01 lambda=3.8810591937350140e-02 Line search: Cubically determined step, current gnorm 6.135131913134e+01 lambda=9.8750504088198892e-03 39 SNES Function norm 6.135131913134e+01 39 SNES VI Function norm 4066.15 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 9.286112632409e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 7.061265007302e+01 lambda=2.9694426041134040e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.436749315348e+01 lambda=2.9694426041134044e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.299789903123e+01 lambda=2.9694426041134044e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.141298285103e+01 lambda=2.9694426041134044e-05 Line search: Cubically determined step, current gnorm 6.135130530880e+01 lambda=2.9694426041134044e-06 40 SNES Function norm 6.135130530880e+01 40 SNES VI Function norm 4066.23 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.660062754407e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.674944119178e+01 lambda=4.3170190544802138e-02 Line search: Cubically determined step, current gnorm 6.120973541057e+01 lambda=6.1770273873522300e-03 41 SNES Function norm 6.120973541057e+01 41 SNES VI Function norm 4152.83 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.564645091492e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.676153862982e+01 lambda=4.4220462778047379e-02 Line search: Cubically determined step, current gnorm 6.104393345352e+01 lambda=6.3589031499342100e-03 42 SNES Function norm 6.104393345352e+01 42 SNES VI Function norm 4233.82 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.368658054045e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.715427252993e+01 lambda=4.7003756543045970e-02 Line search: Cubically determined step, current gnorm 6.101753259623e+01 lambda=6.3787492486959132e-03 43 SNES Function norm 6.101753259623e+01 43 SNES VI Function norm 4314.49 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 8.442307716417e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.496496980051e+01 lambda=4.5726539795380154e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.142635208964e+01 lambda=8.4157732414286580e-03 Line search: Cubically determined step, current gnorm 6.095430498328e+01 lambda=2.1294466610363495e-03 44 SNES Function norm 6.095430498328e+01 44 SNES VI Function norm 4341.47 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 12 Line search: gnorm after quadratic fit 8.439891204437e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.240254752159e+01 lambda=4.3289599290802970e-02 Line search: Cubically determined step, current gnorm 6.081365387079e+01 lambda=1.2916446928212236e-02 45 SNES Function norm 6.081365387079e+01 45 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 9.664056729635e+01 Line search: Cubic step no good, shrinking lambda, current gnorm 6.944851102419e+01 lambda=1.8635858087631831e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.394837998027e+01 lambda=1.8635858087631832e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.278442438314e+01 lambda=1.8635858087631834e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.093400706607e+01 lambda=1.8635858087631834e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081489139942e+01 lambda=1.8635858087631835e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365630503e+01 lambda=1.8635858087631836e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365482998e+01 lambda=7.3438624052552081e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365418254e+01 lambda=2.3870801624167493e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365397577e+01 lambda=8.0330117961387493e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365390593e+01 lambda=2.6874115312641255e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388261e+01 lambda=8.9982494953058537e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387467e+01 lambda=3.0083351315759278e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387219e+01 lambda=1.0110298276678126e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387129e+01 lambda=3.3292703628714462e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387093e+01 lambda=1.0739379834615402e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=3.6237724732408161e-12 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=1.2456833192766385e-12 Line search: Cubically determined step, current gnorm 6.081365387079e+01 lambda=3.5247146389212346e-13 46 SNES Function norm 6.081365387079e+01 46 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 1.433547268242e+03 Line search: Cubic step no good, shrinking lambda, current gnorm 7.106740636849e+01 lambda=2.4859604812085913e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.525497375887e+01 lambda=7.2498301889276232e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.367730849091e+01 lambda=7.2498301889276236e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.174333248068e+01 lambda=7.2498301889276242e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 6.083400168850e+01 lambda=7.2498301889276242e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081378891362e+01 lambda=7.2498301889276242e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365527548e+01 lambda=1.0753239548189211e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365445012e+01 lambda=4.4350670800939511e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365407923e+01 lambda=1.5953160232199837e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365394762e+01 lambda=5.8822684037182187e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365389903e+01 lambda=2.1599843490971948e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388111e+01 lambda=7.9357831777119289e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387457e+01 lambda=2.9181178721013368e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387223e+01 lambda=1.0733281860745436e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387132e+01 lambda=3.9236995040615546e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387106e+01 lambda=1.4351792294805992e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387081e+01 lambda=4.8683006404131606e-12 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387087e+01 lambda=2.0863028416245319e-12 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387080e+01 lambda=5.3058618006527772e-13 Line search: unable to find good step length! After 19 tries Line search: fnorm=6.0813653870787959e+01, gnorm=6.0813653870799314e+01, ynorm=7.0504021074247237e+02, minlambda=9.9999999999999998e-13, lambda=5.3058618006527772e-13, initial slope=-4.7232673282579080e+03 47 SNES Function norm 6.081365387079e+01 47 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 1.280890413731e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.053050135324e+01 lambda=2.2733898438250671e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.399979736493e+01 lambda=2.2733898438250673e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.297299206174e+01 lambda=2.2733898438250674e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.098427084652e+01 lambda=2.2733898438250677e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081555475063e+01 lambda=2.2733898438250679e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365745105e+01 lambda=2.2733898438250681e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365507363e+01 lambda=9.2077672155667702e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365429323e+01 lambda=3.2329991301020441e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365402243e+01 lambda=1.1595563414967544e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365392495e+01 lambda=4.1432803927719340e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365389024e+01 lambda=1.4815603373453140e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387781e+01 lambda=5.2922825349649990e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387324e+01 lambda=1.8866396505817014e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387173e+01 lambda=6.7568116386381729e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387107e+01 lambda=2.3800109593117919e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387094e+01 lambda=8.6880387507986266e-12 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=2.8858967256610185e-12 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=1.0348935437400166e-12 Line search: Cubically determined step, current gnorm 6.081365387077e+01 lambda=2.7070538024707468e-13 48 SNES Function norm 6.081365387077e+01 48 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 11 Line search: gnorm after quadratic fit 1.170943716019e+02 Line search: Cubic step no good, shrinking lambda, current gnorm 7.038597782185e+01 lambda=2.2207476459146142e-02 Line search: Cubic step no good, shrinking lambda, current gnorm 6.399318571001e+01 lambda=2.2207476459146142e-03 Line search: Cubic step no good, shrinking lambda, current gnorm 6.295164029113e+01 lambda=2.2207476459146143e-04 Line search: Cubic step no good, shrinking lambda, current gnorm 6.097743654776e+01 lambda=2.2207476459146143e-05 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081546079136e+01 lambda=2.2207476459146144e-06 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365719872e+01 lambda=2.2207476459146145e-07 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365503919e+01 lambda=9.0117449908413481e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365427749e+01 lambda=3.1364523245356123e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365401596e+01 lambda=1.1183735694685806e-08 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365392232e+01 lambda=3.9706025565052754e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388909e+01 lambda=1.4107330444508480e-09 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387724e+01 lambda=5.0110371464381371e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387308e+01 lambda=1.7820909495605996e-10 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387164e+01 lambda=6.3314737242538209e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387114e+01 lambda=2.2207910898013729e-11 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387085e+01 lambda=7.4515329000007742e-12 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=2.7872933392432575e-12 Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=8.8269934321345058e-13 Line search: unable to find good step length! After 18 tries Line search: fnorm=6.0813653870766274e+01, gnorm=6.0813653870831025e+01, ynorm=7.0578565675503091e+02, minlambda=9.9999999999999998e-13, lambda=8.8269934321345058e-13, initial slope=-3.8123379550451641e+03 Nonlinear solve did not converge due to DIVERGED_LINE_SEARCH iterations 48 Amir On Aug 18 2018, at 11:42 pm, Smith, Barry F. wrote: > > > -snes_monitor -snes_linesearch_monitor -pc_type lu > produces what? > Barry > The line search failing means that the direction computed is not a descent direction which could be due to a bad Jacobian or inconsistent constraints. > > > On Aug 17, 2018, at 11:56 PM, Amir wrote: > > Hi > > I need to apply constraint to primitive variables. I am troubling to set up SNESVI. After running the code, I feel SNES is not actually solving. After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in function norm. > > I think the way I set VI maybe wrong. Sorry for my simple explanation. > > Very thankful for your time. > > Amir > > SNESCreate(PETSC_COMM_WORLD,&snes); > > SNESSetApplicationContext(snes,&user); > > SNESSetDM(snes,user.dm); > > SNESSetFunction(snes,NULL,FormFunction,&user); > > FormInitialSolution(user.X,&user); > > SNESSetSolution(snes,user.X); > > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > > SNESSetType(snes,SNESVINEWTONSSLS); > > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > > SNESGetLineSearch(snes,&linesearch); > > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > > SNESSetFromOptions(snes); > > SNESSolve(snes,NULL,user.X); > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Sun Aug 19 09:26:47 2018 From: knepley at gmail.com (Matthew Knepley) Date: Sun, 19 Aug 2018 10:26:47 -0400 Subject: [petsc-users] Setting SNESVI In-Reply-To: <1534687923.local-d7e5039a-f013-v1.4.2-f587b7b7@getmailspring.com> References: <59E591C6-5596-40DB-AB01-7C2139D0158C@anl.gov> <1534687923.local-d7e5039a-f013-v1.4.2-f587b7b7@getmailspring.com> Message-ID: On Sun, Aug 19, 2018 at 10:19 AM Amir wrote: > This is what I get after I modify the constraints, and using lu: > 0 SNES Function norm 6.839975279451e+01 > 0 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 1 > Line search: gnorm after quadratic fit 1.167382139621e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.661035212791e+01 lambda=1.4620823686291085e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.872462383177e+01 lambda=1.4620823686291085e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.010735352812e+01 lambda=1.4620823686291087e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.845164828370e+01 lambda=1.4620823686291088e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.840024692820e+01 lambda=1.4620823686291089e-06 > Line search: Cubically determined step, current gnorm 6.839974867692e+01 > lambda=1.4620823686291089e-07 > So clearly the direction coming out of your Newton equation is not a descent direction when combined with the constraints. Since it solves fine without the constraints, I suspect that your Jacobian is alright and your constraints are inconsistent with the solution. Step 1, look at the solution you get without constraints. How does it violate your constraints? Matt > 1 SNES Function norm 6.839974867692e+01 > 1 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 1 > Line search: gnorm after quadratic fit 1.313376791907e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.102614855398e+02 lambda=1.4115774027030809e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 9.096517666290e+01 lambda=1.4115774027030810e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.587134084601e+01 lambda=1.4115774027030810e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.877273920434e+01 lambda=1.4115774027030810e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.840408582565e+01 lambda=1.4115774027030811e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.839977811504e+01 lambda=1.4115774027030813e-07 > Line search: Cubically determined step, current gnorm 6.839974761445e+01 > lambda=1.7645101306134412e-08 > 2 SNES Function norm 6.839974761445e+01 > 2 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 1.053816835919e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.064875244204e+02 lambda=2.9620424834498244e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.928160190384e+01 lambda=2.9620424834498247e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.462621000022e+01 lambda=2.9620424834498249e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.862607236334e+01 lambda=2.9620424834498250e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.840219410268e+01 lambda=2.9620424834498251e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.839975697009e+01 lambda=2.9620424834498251e-07 > Line search: Cubically determined step, current gnorm 6.839974486019e+01 > lambda=1.0073837635308560e-07 > 3 SNES Function norm 6.839974486019e+01 > 3 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 1.235990792724e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 1.013971718389e+02 lambda=2.3488863243422971e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.781731557824e+01 lambda=2.3488863243422975e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.872972483427e+01 lambda=2.3488863243422976e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.840207967049e+01 lambda=2.3488863243422978e-05 > Line search: Cubically determined step, current gnorm 6.839957781288e+01 > lambda=4.7431867318372446e-06 > 4 SNES Function norm 6.839957781288e+01 > 4 SNES VI Function norm 68.4009 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 1.076412782767e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.067259042361e+01 lambda=2.9654955573060381e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.991099677071e+01 lambda=2.9654955573060384e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.841319422751e+01 lambda=2.9654955573060385e-04 > Line search: Cubically determined step, current gnorm 6.839661391957e+01 > lambda=8.6072251116571315e-05 > 5 SNES Function norm 6.839661391957e+01 > 5 SNES VI Function norm 68.4308 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 9.167521781305e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.101349837507e+01 lambda=6.4300240519536755e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.041475585659e+01 lambda=6.6547102741568651e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.844705599568e+01 lambda=6.6547102741568653e-04 > Line search: Cubically determined step, current gnorm 6.839121015135e+01 > lambda=1.4965127147397144e-04 > 6 SNES Function norm 6.839121015135e+01 > 6 SNES VI Function norm 68.5745 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 3 > Line search: gnorm after quadratic fit 9.587731188484e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 8.197287845440e+01 lambda=5.2775823101139679e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.940305546680e+01 lambda=5.2775823101139686e-03 > Line search: Cubically determined step, current gnorm 6.837177518619e+01 > lambda=6.3969948101878912e-04 > 7 SNES Function norm 6.837177518619e+01 > 7 SNES VI Function norm 71.0652 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 3 > Line search: gnorm after quadratic fit 9.548865181502e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.876974019161e+01 lambda=5.0026957605696178e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.891985531663e+01 lambda=5.1260581886742491e-03 > Line search: Cubically determined step, current gnorm 6.832012833110e+01 > lambda=9.3300874565775075e-04 > 8 SNES Function norm 6.832012833110e+01 > 8 SNES VI Function norm 79.8569 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 4 > Line search: gnorm after quadratic fit 9.541909192352e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.493349067288e+01 lambda=5.1388541796399699e-02 > Line search: Cubically determined step, current gnorm 6.781311229195e+01 > lambda=7.6704381452756282e-03 > 9 SNES Function norm 6.781311229195e+01 > 9 SNES VI Function norm 206.467 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 6 > Line search: gnorm after quadratic fit 9.394254710662e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.306526091645e+01 lambda=5.3539445292607950e-02 > Line search: Cubically determined step, current gnorm 6.721835250392e+01 > lambda=9.5561464381222188e-03 > 10 SNES Function norm 6.721835250392e+01 > 10 SNES VI Function norm 368.277 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 7 > Line search: gnorm after quadratic fit 9.387716261564e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.070868333837e+01 lambda=4.9443994240769853e-02 > Line search: Cubically determined step, current gnorm 6.660967991379e+01 > lambda=1.0810468882260445e-02 > 11 SNES Function norm 6.660967991379e+01 > 11 SNES VI Function norm 567.089 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 9 > Line search: gnorm after quadratic fit 9.346306901087e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.048649174104e+01 lambda=4.9192073733008407e-02 > Line search: Cubically determined step, current gnorm 6.608645472517e+01 > lambda=1.0044112192046832e-02 > 12 SNES Function norm 6.608645472517e+01 > 12 SNES VI Function norm 734.752 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 8 > Line search: gnorm after quadratic fit 9.452595067062e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.208837086000e+01 lambda=4.5128845776024190e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.800731174084e+01 lambda=6.5132735322282484e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.634685717588e+01 lambda=6.5132735322282484e-04 > Line search: Cubically determined step, current gnorm 6.608637269301e+01 > lambda=6.5132735322282487e-05 > 13 SNES Function norm 6.608637269301e+01 > 13 SNES VI Function norm 735.814 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 8 > Line search: gnorm after quadratic fit 9.318693996551e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.139943393009e+01 lambda=4.8118075850982413e-02 > Line search: Cubically determined step, current gnorm 6.568600823304e+01 > lambda=7.8756632431255542e-03 > 14 SNES Function norm 6.568600823304e+01 > 14 SNES VI Function norm 881.479 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 9 > Line search: gnorm after quadratic fit 9.242424276014e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.226307852468e+01 lambda=4.8021995541678457e-02 > Line search: Cubically determined step, current gnorm 6.540144178550e+01 > lambda=6.6931701304969058e-03 > 15 SNES Function norm 6.540144178550e+01 > 15 SNES VI Function norm 1006.28 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.154992244384e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.122067564574e+01 lambda=5.0277415210907568e-02 > Line search: Cubically determined step, current gnorm 6.506969399500e+01 > lambda=7.8660529387648906e-03 > 16 SNES Function norm 6.506969399500e+01 > 16 SNES VI Function norm 1131.4 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.263744099217e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.045825559590e+01 lambda=4.3976587783298791e-02 > Line search: Cubically determined step, current gnorm 6.477740872258e+01 > lambda=6.6653314620139965e-03 > 17 SNES Function norm 6.477740872258e+01 > 17 SNES VI Function norm 1252.29 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.034042193429e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.097176730586e+01 lambda=4.9082849797732621e-02 > Line search: Cubically determined step, current gnorm 6.448770943479e+01 > lambda=7.1730414269226593e-03 > 18 SNES Function norm 6.448770943479e+01 > 18 SNES VI Function norm 1371.72 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.028256513212e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.990381886066e+01 lambda=4.4193294185915478e-02 > Line search: Cubically determined step, current gnorm 6.422123220407e+01 > lambda=6.6250183714544201e-03 > 19 SNES Function norm 6.422123220407e+01 > 19 SNES VI Function norm 1490.87 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.908334154738e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.060161630260e+01 lambda=4.6452357120490895e-02 > Line search: Cubically determined step, current gnorm 6.411445689017e+01 > lambda=6.3417192629449783e-03 > 20 SNES Function norm 6.411445689017e+01 > 20 SNES VI Function norm 1597.29 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.460267552084e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.051195181220e+01 lambda=5.8933530173091400e-02 > Line search: Cubically determined step, current gnorm 6.379276529842e+01 > lambda=9.2451193719573169e-03 > 21 SNES Function norm 6.379276529842e+01 > 21 SNES VI Function norm 1729.35 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.847710713735e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.007434740347e+01 lambda=4.8620669909360585e-02 > Line search: Cubically determined step, current gnorm 6.358026444281e+01 > lambda=6.8922394760267177e-03 > 22 SNES Function norm 6.358026444281e+01 > 22 SNES VI Function norm 1849.77 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.435581241699e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.335475468652e+01 lambda=3.2814238215953598e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.652843583618e+01 lambda=3.2814238215953598e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.529985391051e+01 lambda=3.2814238215953602e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.366726270581e+01 lambda=3.2814238215953603e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.358115196460e+01 lambda=3.2814238215953603e-06 > Line search: Cubically determined step, current gnorm 6.358025861312e+01 > lambda=3.2814238215953605e-07 > 23 SNES Function norm 6.358025861312e+01 > 23 SNES VI Function norm 1849.78 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.812900895448e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.822426303212e+01 lambda=4.8421685266110105e-02 > Line search: Cubically determined step, current gnorm 6.335842666537e+01 > lambda=8.4588034499471741e-03 > 24 SNES Function norm 6.335842666537e+01 > 24 SNES VI Function norm 1993.6 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.094159193064e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.742173830047e+01 lambda=4.3243453252109078e-02 > Line search: Cubically determined step, current gnorm 6.316236273224e+01 > lambda=7.7494584282214512e-03 > 25 SNES Function norm 6.316236273224e+01 > 25 SNES VI Function norm 2126.62 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.160540289460e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.722886652974e+01 lambda=4.1792497999647044e-02 > Line search: Cubically determined step, current gnorm 6.300020419956e+01 > lambda=7.3335939016311632e-03 > 26 SNES Function norm 6.300020419956e+01 > 26 SNES VI Function norm 2252.12 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.890109786397e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.686097246249e+01 lambda=4.7041389395739201e-02 > Line search: Cubically determined step, current gnorm 6.283084254493e+01 > lambda=9.0792221408297433e-03 > 27 SNES Function norm 6.283084254493e+01 > 27 SNES VI Function norm 2404.84 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.998798828268e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.576469464321e+01 lambda=4.2887406731046039e-02 > Line search: Cubically determined step, current gnorm 6.266968273817e+01 > lambda=9.2948647727201898e-03 > 28 SNES Function norm 6.266968273817e+01 > 28 SNES VI Function norm 2558.11 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.199146621649e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.564298288247e+01 lambda=4.0193768728643060e-02 > Line search: Cubically determined step, current gnorm 6.252861090423e+01 > lambda=8.3932894622200105e-03 > 29 SNES Function norm 6.252861090423e+01 > 29 SNES VI Function norm 2698.56 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.382191898563e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.772162800128e+01 lambda=3.5914901407691102e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.485302824556e+01 lambda=4.7901702628153379e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.285215446174e+01 lambda=4.7901702628153379e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.253029194340e+01 lambda=4.7901702628153380e-05 > Line search: Cubically determined step, current gnorm 6.252812967035e+01 > lambda=1.5127710264417741e-05 > 30 SNES Function norm 6.252812967035e+01 > 30 SNES VI Function norm 2698.83 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.118652411357e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.495202040381e+01 lambda=4.0596953253201326e-02 > Line search: Cubically determined step, current gnorm 6.239041273754e+01 > lambda=9.5128837682561859e-03 > 31 SNES Function norm 6.239041273754e+01 > 31 SNES VI Function norm 2854.38 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.077825361440e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.467284344645e+01 lambda=4.0583557291813177e-02 > Line search: Cubically determined step, current gnorm 6.225884047363e+01 > lambda=9.7846838097028124e-03 > 32 SNES Function norm 6.225884047363e+01 > 32 SNES VI Function norm 3012.55 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.920999190500e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.466103609666e+01 lambda=4.2498592612658738e-02 > Line search: Cubically determined step, current gnorm 6.213582712328e+01 > lambda=1.0171220001350099e-02 > 33 SNES Function norm 6.213582712328e+01 > 33 SNES VI Function norm 3175.23 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.011924620812e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.495110751676e+01 lambda=4.2453491229013124e-02 > Line search: Cubically determined step, current gnorm 6.201636649414e+01 > lambda=9.3685443832871688e-03 > 34 SNES Function norm 6.201636649414e+01 > 34 SNES VI Function norm 3322.22 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.006024690051e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.414041989575e+01 lambda=4.0940226638739433e-02 > Line search: Cubically determined step, current gnorm 6.190218472271e+01 > lambda=1.0273994032172384e-02 > 35 SNES Function norm 6.190218472271e+01 > 35 SNES VI Function norm 3484.25 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.898991234613e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.426189506521e+01 lambda=4.3426020819675164e-02 > Line search: Cubically determined step, current gnorm 6.178678684779e+01 > lambda=1.0559984512509757e-02 > 36 SNES Function norm 6.178678684779e+01 > 36 SNES VI Function norm 3648.36 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.648025040907e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.404650680722e+01 lambda=4.6749921483990771e-02 > Line search: Cubically determined step, current gnorm 6.165099494681e+01 > lambda=1.1866483746353381e-02 > 37 SNES Function norm 6.165099494681e+01 > 37 SNES VI Function norm 3822.88 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.858076523292e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.520416756669e+01 lambda=4.2063577748779259e-02 > Line search: Cubically determined step, current gnorm 6.152598711257e+01 > lambda=7.9475995139781722e-03 > 38 SNES Function norm 6.152598711257e+01 > 38 SNES VI Function norm 3944.22 Active lower constraints 0/0 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.742192022113e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.343055909293e+01 lambda=3.8810591937350140e-02 > Line search: Cubically determined step, current gnorm 6.135131913134e+01 > lambda=9.8750504088198892e-03 > 39 SNES Function norm 6.135131913134e+01 > 39 SNES VI Function norm 4066.15 Active lower constraints 0/1 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.286112632409e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.061265007302e+01 lambda=2.9694426041134040e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.436749315348e+01 lambda=2.9694426041134044e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.299789903123e+01 lambda=2.9694426041134044e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.141298285103e+01 lambda=2.9694426041134044e-05 > Line search: Cubically determined step, current gnorm 6.135130530880e+01 > lambda=2.9694426041134044e-06 > 40 SNES Function norm 6.135130530880e+01 > 40 SNES VI Function norm 4066.23 Active lower constraints 0/1 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.660062754407e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.674944119178e+01 lambda=4.3170190544802138e-02 > Line search: Cubically determined step, current gnorm 6.120973541057e+01 > lambda=6.1770273873522300e-03 > 41 SNES Function norm 6.120973541057e+01 > 41 SNES VI Function norm 4152.83 Active lower constraints 0/1 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.564645091492e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.676153862982e+01 lambda=4.4220462778047379e-02 > Line search: Cubically determined step, current gnorm 6.104393345352e+01 > lambda=6.3589031499342100e-03 > 42 SNES Function norm 6.104393345352e+01 > 42 SNES VI Function norm 4233.82 Active lower constraints 0/1 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.368658054045e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.715427252993e+01 lambda=4.7003756543045970e-02 > Line search: Cubically determined step, current gnorm 6.101753259623e+01 > lambda=6.3787492486959132e-03 > 43 SNES Function norm 6.101753259623e+01 > 43 SNES VI Function norm 4314.49 Active lower constraints 0/1 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.442307716417e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.496496980051e+01 lambda=4.5726539795380154e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.142635208964e+01 lambda=8.4157732414286580e-03 > Line search: Cubically determined step, current gnorm 6.095430498328e+01 > lambda=2.1294466610363495e-03 > 44 SNES Function norm 6.095430498328e+01 > 44 SNES VI Function norm 4341.47 Active lower constraints 0/1 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 12 > Line search: gnorm after quadratic fit 8.439891204437e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.240254752159e+01 lambda=4.3289599290802970e-02 > Line search: Cubically determined step, current gnorm 6.081365387079e+01 > lambda=1.2916446928212236e-02 > 45 SNES Function norm 6.081365387079e+01 > 45 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.664056729635e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.944851102419e+01 lambda=1.8635858087631831e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.394837998027e+01 lambda=1.8635858087631832e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.278442438314e+01 lambda=1.8635858087631834e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.093400706607e+01 lambda=1.8635858087631834e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081489139942e+01 lambda=1.8635858087631835e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365630503e+01 lambda=1.8635858087631836e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365482998e+01 lambda=7.3438624052552081e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365418254e+01 lambda=2.3870801624167493e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365397577e+01 lambda=8.0330117961387493e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365390593e+01 lambda=2.6874115312641255e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365388261e+01 lambda=8.9982494953058537e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387467e+01 lambda=3.0083351315759278e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387219e+01 lambda=1.0110298276678126e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387129e+01 lambda=3.3292703628714462e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387093e+01 lambda=1.0739379834615402e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387083e+01 lambda=3.6237724732408161e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387082e+01 lambda=1.2456833192766385e-12 > Line search: Cubically determined step, current gnorm 6.081365387079e+01 > lambda=3.5247146389212346e-13 > 46 SNES Function norm 6.081365387079e+01 > 46 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 1.433547268242e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.106740636849e+01 lambda=2.4859604812085913e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.525497375887e+01 lambda=7.2498301889276232e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.367730849091e+01 lambda=7.2498301889276236e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.174333248068e+01 lambda=7.2498301889276242e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.083400168850e+01 lambda=7.2498301889276242e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081378891362e+01 lambda=7.2498301889276242e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365527548e+01 lambda=1.0753239548189211e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365445012e+01 lambda=4.4350670800939511e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365407923e+01 lambda=1.5953160232199837e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365394762e+01 lambda=5.8822684037182187e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365389903e+01 lambda=2.1599843490971948e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365388111e+01 lambda=7.9357831777119289e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387457e+01 lambda=2.9181178721013368e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387223e+01 lambda=1.0733281860745436e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387132e+01 lambda=3.9236995040615546e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387106e+01 lambda=1.4351792294805992e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387081e+01 lambda=4.8683006404131606e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387087e+01 lambda=2.0863028416245319e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387080e+01 lambda=5.3058618006527772e-13 > Line search: unable to find good step length! After 19 tries > Line search: fnorm=6.0813653870787959e+01, gnorm=6.0813653870799314e+01, > ynorm=7.0504021074247237e+02, minlambda=9.9999999999999998e-13, > lambda=5.3058618006527772e-13, initial slope=-4.7232673282579080e+03 > 47 SNES Function norm 6.081365387079e+01 > 47 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 1.280890413731e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.053050135324e+01 lambda=2.2733898438250671e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.399979736493e+01 lambda=2.2733898438250673e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.297299206174e+01 lambda=2.2733898438250674e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.098427084652e+01 lambda=2.2733898438250677e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081555475063e+01 lambda=2.2733898438250679e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365745105e+01 lambda=2.2733898438250681e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365507363e+01 lambda=9.2077672155667702e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365429323e+01 lambda=3.2329991301020441e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365402243e+01 lambda=1.1595563414967544e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365392495e+01 lambda=4.1432803927719340e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365389024e+01 lambda=1.4815603373453140e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387781e+01 lambda=5.2922825349649990e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387324e+01 lambda=1.8866396505817014e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387173e+01 lambda=6.7568116386381729e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387107e+01 lambda=2.3800109593117919e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387094e+01 lambda=8.6880387507986266e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387083e+01 lambda=2.8858967256610185e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387082e+01 lambda=1.0348935437400166e-12 > Line search: Cubically determined step, current gnorm 6.081365387077e+01 > lambda=2.7070538024707468e-13 > 48 SNES Function norm 6.081365387077e+01 > 48 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper > constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 1.170943716019e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 7.038597782185e+01 lambda=2.2207476459146142e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.399318571001e+01 lambda=2.2207476459146142e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.295164029113e+01 lambda=2.2207476459146143e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.097743654776e+01 lambda=2.2207476459146143e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081546079136e+01 lambda=2.2207476459146144e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365719872e+01 lambda=2.2207476459146145e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365503919e+01 lambda=9.0117449908413481e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365427749e+01 lambda=3.1364523245356123e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365401596e+01 lambda=1.1183735694685806e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365392232e+01 lambda=3.9706025565052754e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365388909e+01 lambda=1.4107330444508480e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387724e+01 lambda=5.0110371464381371e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387308e+01 lambda=1.7820909495605996e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387164e+01 lambda=6.3314737242538209e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387114e+01 lambda=2.2207910898013729e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387085e+01 lambda=7.4515329000007742e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387082e+01 lambda=2.7872933392432575e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm > 6.081365387083e+01 lambda=8.8269934321345058e-13 > Line search: unable to find good step length! After 18 tries > Line search: fnorm=6.0813653870766274e+01, gnorm=6.0813653870831025e+01, > ynorm=7.0578565675503091e+02, minlambda=9.9999999999999998e-13, > lambda=8.8269934321345058e-13, initial slope=-3.8123379550451641e+03 > Nonlinear solve did not converge due to DIVERGED_LINE_SEARCH iterations 48 > > Amir > > On Aug 18 2018, at 11:42 pm, Smith, Barry F. wrote: > > > > -snes_monitor -snes_linesearch_monitor -pc_type lu > > produces what? > > Barry > > The line search failing means that the direction computed is not a descent > direction which could be due to a bad Jacobian or inconsistent constraints. > > > On Aug 17, 2018, at 11:56 PM, Amir wrote: > > Hi > I need to apply constraint to primitive variables. I am troubling to set > up SNESVI. After running the code, I feel SNES is not actually solving. > After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in > function norm. > I think the way I set VI maybe wrong. Sorry for my simple explanation. > Very thankful for your time. > Amir > SNESCreate(PETSC_COMM_WORLD,&snes); > SNESSetApplicationContext(snes,&user); > SNESSetDM(snes,user.dm); > SNESSetFunction(snes,NULL,FormFunction,&user); > FormInitialSolution(user.X,&user); > SNESSetSolution(snes,user.X); > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > SNESSetType(snes,SNESVINEWTONSSLS); > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > SNESGetLineSearch(snes,&linesearch); > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > SNESSetFromOptions(snes); > SNESSolve(snes,NULL,user.X); > > [image: Open Tracking] -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From mhbaghaei at mail.sjtu.edu.cn Sun Aug 19 10:00:22 2018 From: mhbaghaei at mail.sjtu.edu.cn (Amir) Date: Sun, 19 Aug 2018 23:00:22 +0800 Subject: [petsc-users] Setting SNESVI In-Reply-To: References: Message-ID: <1534690328.local-0af8bd50-526f-v1.4.2-f587b7b7@getmailspring.com> Thanks for your guide. By monitoring the solutions during SNES, until it was diverged, I noticed that only at, same, one point, located on boundary, and at, same, one field, repeatedly the solution went out of my specified constraint. Amir On Aug 19 2018, at 10:26 pm, Matthew Knepley wrote: > > On Sun, Aug 19, 2018 at 10:19 AM Amir wrote: > > This is what I get after I modify the constraints, and using lu: > > 0 SNES Function norm 6.839975279451e+01 > > 0 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 1.167382139621e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.661035212791e+01 lambda=1.4620823686291085e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.872462383177e+01 lambda=1.4620823686291085e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.010735352812e+01 lambda=1.4620823686291087e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.845164828370e+01 lambda=1.4620823686291088e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840024692820e+01 lambda=1.4620823686291089e-06 > > Line search: Cubically determined step, current gnorm 6.839974867692e+01 lambda=1.4620823686291089e-07 > > > So clearly the direction coming out of your Newton equation is not a descent direction when combined with the constraints. Since > it solves fine without the constraints, I suspect that your Jacobian is alright and your constraints are inconsistent with the solution. > Step 1, look at the solution you get without constraints. How does it violate your constraints? > > Matt > > > 1 SNES Function norm 6.839974867692e+01 > > 1 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 1.313376791907e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.102614855398e+02 lambda=1.4115774027030809e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.096517666290e+01 lambda=1.4115774027030810e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.587134084601e+01 lambda=1.4115774027030810e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.877273920434e+01 lambda=1.4115774027030810e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840408582565e+01 lambda=1.4115774027030811e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.839977811504e+01 lambda=1.4115774027030813e-07 > > Line search: Cubically determined step, current gnorm 6.839974761445e+01 lambda=1.7645101306134412e-08 > > 2 SNES Function norm 6.839974761445e+01 > > 2 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 2 > > Line search: gnorm after quadratic fit 1.053816835919e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.064875244204e+02 lambda=2.9620424834498244e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.928160190384e+01 lambda=2.9620424834498247e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.462621000022e+01 lambda=2.9620424834498249e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.862607236334e+01 lambda=2.9620424834498250e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840219410268e+01 lambda=2.9620424834498251e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.839975697009e+01 lambda=2.9620424834498251e-07 > > Line search: Cubically determined step, current gnorm 6.839974486019e+01 lambda=1.0073837635308560e-07 > > 3 SNES Function norm 6.839974486019e+01 > > 3 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 2 > > Line search: gnorm after quadratic fit 1.235990792724e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.013971718389e+02 lambda=2.3488863243422971e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.781731557824e+01 lambda=2.3488863243422975e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.872972483427e+01 lambda=2.3488863243422976e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840207967049e+01 lambda=2.3488863243422978e-05 > > Line search: Cubically determined step, current gnorm 6.839957781288e+01 lambda=4.7431867318372446e-06 > > 4 SNES Function norm 6.839957781288e+01 > > 4 SNES VI Function norm 68.4009 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 2 > > Line search: gnorm after quadratic fit 1.076412782767e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.067259042361e+01 lambda=2.9654955573060381e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.991099677071e+01 lambda=2.9654955573060384e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.841319422751e+01 lambda=2.9654955573060385e-04 > > Line search: Cubically determined step, current gnorm 6.839661391957e+01 lambda=8.6072251116571315e-05 > > 5 SNES Function norm 6.839661391957e+01 > > 5 SNES VI Function norm 68.4308 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 2 > > Line search: gnorm after quadratic fit 9.167521781305e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.101349837507e+01 lambda=6.4300240519536755e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.041475585659e+01 lambda=6.6547102741568651e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.844705599568e+01 lambda=6.6547102741568653e-04 > > Line search: Cubically determined step, current gnorm 6.839121015135e+01 lambda=1.4965127147397144e-04 > > 6 SNES Function norm 6.839121015135e+01 > > 6 SNES VI Function norm 68.5745 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 3 > > Line search: gnorm after quadratic fit 9.587731188484e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.197287845440e+01 lambda=5.2775823101139679e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.940305546680e+01 lambda=5.2775823101139686e-03 > > Line search: Cubically determined step, current gnorm 6.837177518619e+01 lambda=6.3969948101878912e-04 > > 7 SNES Function norm 6.837177518619e+01 > > 7 SNES VI Function norm 71.0652 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 3 > > Line search: gnorm after quadratic fit 9.548865181502e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.876974019161e+01 lambda=5.0026957605696178e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.891985531663e+01 lambda=5.1260581886742491e-03 > > Line search: Cubically determined step, current gnorm 6.832012833110e+01 lambda=9.3300874565775075e-04 > > 8 SNES Function norm 6.832012833110e+01 > > 8 SNES VI Function norm 79.8569 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 4 > > Line search: gnorm after quadratic fit 9.541909192352e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.493349067288e+01 lambda=5.1388541796399699e-02 > > Line search: Cubically determined step, current gnorm 6.781311229195e+01 lambda=7.6704381452756282e-03 > > 9 SNES Function norm 6.781311229195e+01 > > 9 SNES VI Function norm 206.467 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 6 > > Line search: gnorm after quadratic fit 9.394254710662e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.306526091645e+01 lambda=5.3539445292607950e-02 > > Line search: Cubically determined step, current gnorm 6.721835250392e+01 lambda=9.5561464381222188e-03 > > 10 SNES Function norm 6.721835250392e+01 > > 10 SNES VI Function norm 368.277 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 7 > > Line search: gnorm after quadratic fit 9.387716261564e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.070868333837e+01 lambda=4.9443994240769853e-02 > > Line search: Cubically determined step, current gnorm 6.660967991379e+01 lambda=1.0810468882260445e-02 > > 11 SNES Function norm 6.660967991379e+01 > > 11 SNES VI Function norm 567.089 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 9 > > Line search: gnorm after quadratic fit 9.346306901087e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.048649174104e+01 lambda=4.9192073733008407e-02 > > Line search: Cubically determined step, current gnorm 6.608645472517e+01 lambda=1.0044112192046832e-02 > > 12 SNES Function norm 6.608645472517e+01 > > 12 SNES VI Function norm 734.752 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 8 > > Line search: gnorm after quadratic fit 9.452595067062e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.208837086000e+01 lambda=4.5128845776024190e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.800731174084e+01 lambda=6.5132735322282484e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.634685717588e+01 lambda=6.5132735322282484e-04 > > Line search: Cubically determined step, current gnorm 6.608637269301e+01 lambda=6.5132735322282487e-05 > > 13 SNES Function norm 6.608637269301e+01 > > 13 SNES VI Function norm 735.814 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 8 > > Line search: gnorm after quadratic fit 9.318693996551e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.139943393009e+01 lambda=4.8118075850982413e-02 > > Line search: Cubically determined step, current gnorm 6.568600823304e+01 lambda=7.8756632431255542e-03 > > 14 SNES Function norm 6.568600823304e+01 > > 14 SNES VI Function norm 881.479 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 9 > > Line search: gnorm after quadratic fit 9.242424276014e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.226307852468e+01 lambda=4.8021995541678457e-02 > > Line search: Cubically determined step, current gnorm 6.540144178550e+01 lambda=6.6931701304969058e-03 > > 15 SNES Function norm 6.540144178550e+01 > > 15 SNES VI Function norm 1006.28 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 9.154992244384e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.122067564574e+01 lambda=5.0277415210907568e-02 > > Line search: Cubically determined step, current gnorm 6.506969399500e+01 lambda=7.8660529387648906e-03 > > 16 SNES Function norm 6.506969399500e+01 > > 16 SNES VI Function norm 1131.4 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 9.263744099217e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.045825559590e+01 lambda=4.3976587783298791e-02 > > Line search: Cubically determined step, current gnorm 6.477740872258e+01 lambda=6.6653314620139965e-03 > > 17 SNES Function norm 6.477740872258e+01 > > 17 SNES VI Function norm 1252.29 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 9.034042193429e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.097176730586e+01 lambda=4.9082849797732621e-02 > > Line search: Cubically determined step, current gnorm 6.448770943479e+01 lambda=7.1730414269226593e-03 > > 18 SNES Function norm 6.448770943479e+01 > > 18 SNES VI Function norm 1371.72 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 9.028256513212e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.990381886066e+01 lambda=4.4193294185915478e-02 > > Line search: Cubically determined step, current gnorm 6.422123220407e+01 lambda=6.6250183714544201e-03 > > 19 SNES Function norm 6.422123220407e+01 > > 19 SNES VI Function norm 1490.87 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 8.908334154738e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.060161630260e+01 lambda=4.6452357120490895e-02 > > Line search: Cubically determined step, current gnorm 6.411445689017e+01 lambda=6.3417192629449783e-03 > > 20 SNES Function norm 6.411445689017e+01 > > 20 SNES VI Function norm 1597.29 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.460267552084e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.051195181220e+01 lambda=5.8933530173091400e-02 > > Line search: Cubically determined step, current gnorm 6.379276529842e+01 lambda=9.2451193719573169e-03 > > 21 SNES Function norm 6.379276529842e+01 > > 21 SNES VI Function norm 1729.35 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 8.847710713735e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.007434740347e+01 lambda=4.8620669909360585e-02 > > Line search: Cubically determined step, current gnorm 6.358026444281e+01 lambda=6.8922394760267177e-03 > > 22 SNES Function norm 6.358026444281e+01 > > 22 SNES VI Function norm 1849.77 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 9.435581241699e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.335475468652e+01 lambda=3.2814238215953598e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.652843583618e+01 lambda=3.2814238215953598e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.529985391051e+01 lambda=3.2814238215953602e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.366726270581e+01 lambda=3.2814238215953603e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.358115196460e+01 lambda=3.2814238215953603e-06 > > Line search: Cubically determined step, current gnorm 6.358025861312e+01 lambda=3.2814238215953605e-07 > > 23 SNES Function norm 6.358025861312e+01 > > 23 SNES VI Function norm 1849.78 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 8.812900895448e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.822426303212e+01 lambda=4.8421685266110105e-02 > > Line search: Cubically determined step, current gnorm 6.335842666537e+01 lambda=8.4588034499471741e-03 > > 24 SNES Function norm 6.335842666537e+01 > > 24 SNES VI Function norm 1993.6 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.094159193064e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.742173830047e+01 lambda=4.3243453252109078e-02 > > Line search: Cubically determined step, current gnorm 6.316236273224e+01 lambda=7.7494584282214512e-03 > > 25 SNES Function norm 6.316236273224e+01 > > 25 SNES VI Function norm 2126.62 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.160540289460e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.722886652974e+01 lambda=4.1792497999647044e-02 > > Line search: Cubically determined step, current gnorm 6.300020419956e+01 lambda=7.3335939016311632e-03 > > 26 SNES Function norm 6.300020419956e+01 > > 26 SNES VI Function norm 2252.12 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 8.890109786397e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.686097246249e+01 lambda=4.7041389395739201e-02 > > Line search: Cubically determined step, current gnorm 6.283084254493e+01 lambda=9.0792221408297433e-03 > > 27 SNES Function norm 6.283084254493e+01 > > 27 SNES VI Function norm 2404.84 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.998798828268e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.576469464321e+01 lambda=4.2887406731046039e-02 > > Line search: Cubically determined step, current gnorm 6.266968273817e+01 lambda=9.2948647727201898e-03 > > 28 SNES Function norm 6.266968273817e+01 > > 28 SNES VI Function norm 2558.11 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.199146621649e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.564298288247e+01 lambda=4.0193768728643060e-02 > > Line search: Cubically determined step, current gnorm 6.252861090423e+01 lambda=8.3932894622200105e-03 > > 29 SNES Function norm 6.252861090423e+01 > > 29 SNES VI Function norm 2698.56 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.382191898563e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.772162800128e+01 lambda=3.5914901407691102e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.485302824556e+01 lambda=4.7901702628153379e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.285215446174e+01 lambda=4.7901702628153379e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.253029194340e+01 lambda=4.7901702628153380e-05 > > Line search: Cubically determined step, current gnorm 6.252812967035e+01 lambda=1.5127710264417741e-05 > > 30 SNES Function norm 6.252812967035e+01 > > 30 SNES VI Function norm 2698.83 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.118652411357e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.495202040381e+01 lambda=4.0596953253201326e-02 > > Line search: Cubically determined step, current gnorm 6.239041273754e+01 lambda=9.5128837682561859e-03 > > 31 SNES Function norm 6.239041273754e+01 > > 31 SNES VI Function norm 2854.38 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.077825361440e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.467284344645e+01 lambda=4.0583557291813177e-02 > > Line search: Cubically determined step, current gnorm 6.225884047363e+01 lambda=9.7846838097028124e-03 > > 32 SNES Function norm 6.225884047363e+01 > > 32 SNES VI Function norm 3012.55 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.920999190500e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.466103609666e+01 lambda=4.2498592612658738e-02 > > Line search: Cubically determined step, current gnorm 6.213582712328e+01 lambda=1.0171220001350099e-02 > > 33 SNES Function norm 6.213582712328e+01 > > 33 SNES VI Function norm 3175.23 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.011924620812e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.495110751676e+01 lambda=4.2453491229013124e-02 > > Line search: Cubically determined step, current gnorm 6.201636649414e+01 lambda=9.3685443832871688e-03 > > 34 SNES Function norm 6.201636649414e+01 > > 34 SNES VI Function norm 3322.22 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.006024690051e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.414041989575e+01 lambda=4.0940226638739433e-02 > > Line search: Cubically determined step, current gnorm 6.190218472271e+01 lambda=1.0273994032172384e-02 > > 35 SNES Function norm 6.190218472271e+01 > > 35 SNES VI Function norm 3484.25 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.898991234613e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.426189506521e+01 lambda=4.3426020819675164e-02 > > Line search: Cubically determined step, current gnorm 6.178678684779e+01 lambda=1.0559984512509757e-02 > > 36 SNES Function norm 6.178678684779e+01 > > 36 SNES VI Function norm 3648.36 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.648025040907e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.404650680722e+01 lambda=4.6749921483990771e-02 > > Line search: Cubically determined step, current gnorm 6.165099494681e+01 lambda=1.1866483746353381e-02 > > 37 SNES Function norm 6.165099494681e+01 > > 37 SNES VI Function norm 3822.88 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.858076523292e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.520416756669e+01 lambda=4.2063577748779259e-02 > > Line search: Cubically determined step, current gnorm 6.152598711257e+01 lambda=7.9475995139781722e-03 > > 38 SNES Function norm 6.152598711257e+01 > > 38 SNES VI Function norm 3944.22 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.742192022113e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.343055909293e+01 lambda=3.8810591937350140e-02 > > Line search: Cubically determined step, current gnorm 6.135131913134e+01 lambda=9.8750504088198892e-03 > > 39 SNES Function norm 6.135131913134e+01 > > 39 SNES VI Function norm 4066.15 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.286112632409e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.061265007302e+01 lambda=2.9694426041134040e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.436749315348e+01 lambda=2.9694426041134044e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.299789903123e+01 lambda=2.9694426041134044e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141298285103e+01 lambda=2.9694426041134044e-05 > > Line search: Cubically determined step, current gnorm 6.135130530880e+01 lambda=2.9694426041134044e-06 > > 40 SNES Function norm 6.135130530880e+01 > > 40 SNES VI Function norm 4066.23 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.660062754407e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.674944119178e+01 lambda=4.3170190544802138e-02 > > Line search: Cubically determined step, current gnorm 6.120973541057e+01 lambda=6.1770273873522300e-03 > > 41 SNES Function norm 6.120973541057e+01 > > 41 SNES VI Function norm 4152.83 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.564645091492e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676153862982e+01 lambda=4.4220462778047379e-02 > > Line search: Cubically determined step, current gnorm 6.104393345352e+01 lambda=6.3589031499342100e-03 > > 42 SNES Function norm 6.104393345352e+01 > > 42 SNES VI Function norm 4233.82 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.368658054045e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.715427252993e+01 lambda=4.7003756543045970e-02 > > Line search: Cubically determined step, current gnorm 6.101753259623e+01 lambda=6.3787492486959132e-03 > > 43 SNES Function norm 6.101753259623e+01 > > 43 SNES VI Function norm 4314.49 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.442307716417e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.496496980051e+01 lambda=4.5726539795380154e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.142635208964e+01 lambda=8.4157732414286580e-03 > > Line search: Cubically determined step, current gnorm 6.095430498328e+01 lambda=2.1294466610363495e-03 > > 44 SNES Function norm 6.095430498328e+01 > > 44 SNES VI Function norm 4341.47 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 12 > > Line search: gnorm after quadratic fit 8.439891204437e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.240254752159e+01 lambda=4.3289599290802970e-02 > > Line search: Cubically determined step, current gnorm 6.081365387079e+01 lambda=1.2916446928212236e-02 > > 45 SNES Function norm 6.081365387079e+01 > > 45 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.664056729635e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.944851102419e+01 lambda=1.8635858087631831e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.394837998027e+01 lambda=1.8635858087631832e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.278442438314e+01 lambda=1.8635858087631834e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.093400706607e+01 lambda=1.8635858087631834e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081489139942e+01 lambda=1.8635858087631835e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365630503e+01 lambda=1.8635858087631836e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365482998e+01 lambda=7.3438624052552081e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365418254e+01 lambda=2.3870801624167493e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365397577e+01 lambda=8.0330117961387493e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365390593e+01 lambda=2.6874115312641255e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388261e+01 lambda=8.9982494953058537e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387467e+01 lambda=3.0083351315759278e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387219e+01 lambda=1.0110298276678126e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387129e+01 lambda=3.3292703628714462e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387093e+01 lambda=1.0739379834615402e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=3.6237724732408161e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=1.2456833192766385e-12 > > Line search: Cubically determined step, current gnorm 6.081365387079e+01 lambda=3.5247146389212346e-13 > > 46 SNES Function norm 6.081365387079e+01 > > 46 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 1.433547268242e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.106740636849e+01 lambda=2.4859604812085913e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.525497375887e+01 lambda=7.2498301889276232e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367730849091e+01 lambda=7.2498301889276236e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.174333248068e+01 lambda=7.2498301889276242e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.083400168850e+01 lambda=7.2498301889276242e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081378891362e+01 lambda=7.2498301889276242e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365527548e+01 lambda=1.0753239548189211e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365445012e+01 lambda=4.4350670800939511e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365407923e+01 lambda=1.5953160232199837e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365394762e+01 lambda=5.8822684037182187e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365389903e+01 lambda=2.1599843490971948e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388111e+01 lambda=7.9357831777119289e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387457e+01 lambda=2.9181178721013368e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387223e+01 lambda=1.0733281860745436e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387132e+01 lambda=3.9236995040615546e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387106e+01 lambda=1.4351792294805992e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387081e+01 lambda=4.8683006404131606e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387087e+01 lambda=2.0863028416245319e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387080e+01 lambda=5.3058618006527772e-13 > > Line search: unable to find good step length! After 19 tries > > Line search: fnorm=6.0813653870787959e+01, gnorm=6.0813653870799314e+01, ynorm=7.0504021074247237e+02, minlambda=9.9999999999999998e-13, lambda=5.3058618006527772e-13, initial slope=-4.7232673282579080e+03 > > 47 SNES Function norm 6.081365387079e+01 > > 47 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 1.280890413731e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.053050135324e+01 lambda=2.2733898438250671e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.399979736493e+01 lambda=2.2733898438250673e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.297299206174e+01 lambda=2.2733898438250674e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.098427084652e+01 lambda=2.2733898438250677e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081555475063e+01 lambda=2.2733898438250679e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365745105e+01 lambda=2.2733898438250681e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365507363e+01 lambda=9.2077672155667702e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365429323e+01 lambda=3.2329991301020441e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365402243e+01 lambda=1.1595563414967544e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365392495e+01 lambda=4.1432803927719340e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365389024e+01 lambda=1.4815603373453140e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387781e+01 lambda=5.2922825349649990e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387324e+01 lambda=1.8866396505817014e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387173e+01 lambda=6.7568116386381729e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387107e+01 lambda=2.3800109593117919e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387094e+01 lambda=8.6880387507986266e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=2.8858967256610185e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=1.0348935437400166e-12 > > Line search: Cubically determined step, current gnorm 6.081365387077e+01 lambda=2.7070538024707468e-13 > > 48 SNES Function norm 6.081365387077e+01 > > 48 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 1.170943716019e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.038597782185e+01 lambda=2.2207476459146142e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.399318571001e+01 lambda=2.2207476459146142e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.295164029113e+01 lambda=2.2207476459146143e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.097743654776e+01 lambda=2.2207476459146143e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081546079136e+01 lambda=2.2207476459146144e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365719872e+01 lambda=2.2207476459146145e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365503919e+01 lambda=9.0117449908413481e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365427749e+01 lambda=3.1364523245356123e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365401596e+01 lambda=1.1183735694685806e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365392232e+01 lambda=3.9706025565052754e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388909e+01 lambda=1.4107330444508480e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387724e+01 lambda=5.0110371464381371e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387308e+01 lambda=1.7820909495605996e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387164e+01 lambda=6.3314737242538209e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387114e+01 lambda=2.2207910898013729e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387085e+01 lambda=7.4515329000007742e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=2.7872933392432575e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=8.8269934321345058e-13 > > Line search: unable to find good step length! After 18 tries > > Line search: fnorm=6.0813653870766274e+01, gnorm=6.0813653870831025e+01, ynorm=7.0578565675503091e+02, minlambda=9.9999999999999998e-13, lambda=8.8269934321345058e-13, initial slope=-3.8123379550451641e+03 > > Nonlinear solve did not converge due to DIVERGED_LINE_SEARCH iterations 48 > > > > Amir > > On Aug 18 2018, at 11:42 pm, Smith, Barry F. wrote: > > > > > > > > > -snes_monitor -snes_linesearch_monitor -pc_type lu > > > produces what? > > > Barry > > > The line search failing means that the direction computed is not a descent direction which could be due to a bad Jacobian or inconsistent constraints. > > > > > > > On Aug 17, 2018, at 11:56 PM, Amir wrote: > > > > Hi > > > > I need to apply constraint to primitive variables. I am troubling to set up SNESVI. After running the code, I feel SNES is not actually solving. After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in function norm. > > > > I think the way I set VI maybe wrong. Sorry for my simple explanation. > > > > Very thankful for your time. > > > > Amir > > > > SNESCreate(PETSC_COMM_WORLD,&snes); > > > > SNESSetApplicationContext(snes,&user); > > > > SNESSetDM(snes,user.dm (http://user.dm)); > > > > SNESSetFunction(snes,NULL,FormFunction,&user); > > > > FormInitialSolution(user.X,&user); > > > > SNESSetSolution(snes,user.X); > > > > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > > > > SNESSetType(snes,SNESVINEWTONSSLS); > > > > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > > > > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > > > > SNESGetLineSearch(snes,&linesearch); > > > > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > > > > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > > > > SNESSetFromOptions(snes); > > > > SNESSolve(snes,NULL,user.X); > > > > > > > > > > > > > > > -- > 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 > > > https://www.cse.buffalo.edu/~knepley/ (http://www.caam.rice.edu/~mk51/) -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sun Aug 19 13:00:01 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Sun, 19 Aug 2018 18:00:01 +0000 Subject: [petsc-users] Setting SNESVI In-Reply-To: <1534687923.local-d7e5039a-f013-v1.4.2-f587b7b7@getmailspring.com> References: <59E591C6-5596-40DB-AB01-7C2139D0158C@anl.gov> <1534687923.local-d7e5039a-f013-v1.4.2-f587b7b7@getmailspring.com> Message-ID: <4CB90C24-E326-43CE-B562-5371BB2092E3@mcs.anl.gov> Note that no constraints are reached at the first iterations despite the terrible convergence. I suspect something is wrong with either the formulation or the Jacobian (that is nothing to do with the constraints). What do you get with the same options if you do not set any constraints? The same terrible convergence or something different (send it). In PETSc 3.9 you can run with the option -snes_test_jacobian to see if the Jacobians are accurate or out of whack. Barry > On Aug 19, 2018, at 9:19 AM, Amir wrote: > > This is what I get after I modify the constraints, and using lu: > 0 SNES Function norm 6.839975279451e+01 > 0 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 1 > Line search: gnorm after quadratic fit 1.167382139621e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.661035212791e+01 lambda=1.4620823686291085e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.872462383177e+01 lambda=1.4620823686291085e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.010735352812e+01 lambda=1.4620823686291087e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.845164828370e+01 lambda=1.4620823686291088e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840024692820e+01 lambda=1.4620823686291089e-06 > Line search: Cubically determined step, current gnorm 6.839974867692e+01 lambda=1.4620823686291089e-07 > 1 SNES Function norm 6.839974867692e+01 > 1 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 1 > Line search: gnorm after quadratic fit 1.313376791907e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.102614855398e+02 lambda=1.4115774027030809e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.096517666290e+01 lambda=1.4115774027030810e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.587134084601e+01 lambda=1.4115774027030810e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.877273920434e+01 lambda=1.4115774027030810e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840408582565e+01 lambda=1.4115774027030811e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.839977811504e+01 lambda=1.4115774027030813e-07 > Line search: Cubically determined step, current gnorm 6.839974761445e+01 lambda=1.7645101306134412e-08 > 2 SNES Function norm 6.839974761445e+01 > 2 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 1.053816835919e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.064875244204e+02 lambda=2.9620424834498244e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.928160190384e+01 lambda=2.9620424834498247e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.462621000022e+01 lambda=2.9620424834498249e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.862607236334e+01 lambda=2.9620424834498250e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840219410268e+01 lambda=2.9620424834498251e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.839975697009e+01 lambda=2.9620424834498251e-07 > Line search: Cubically determined step, current gnorm 6.839974486019e+01 lambda=1.0073837635308560e-07 > 3 SNES Function norm 6.839974486019e+01 > 3 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 1.235990792724e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.013971718389e+02 lambda=2.3488863243422971e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.781731557824e+01 lambda=2.3488863243422975e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.872972483427e+01 lambda=2.3488863243422976e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840207967049e+01 lambda=2.3488863243422978e-05 > Line search: Cubically determined step, current gnorm 6.839957781288e+01 lambda=4.7431867318372446e-06 > 4 SNES Function norm 6.839957781288e+01 > 4 SNES VI Function norm 68.4009 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 1.076412782767e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.067259042361e+01 lambda=2.9654955573060381e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.991099677071e+01 lambda=2.9654955573060384e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.841319422751e+01 lambda=2.9654955573060385e-04 > Line search: Cubically determined step, current gnorm 6.839661391957e+01 lambda=8.6072251116571315e-05 > 5 SNES Function norm 6.839661391957e+01 > 5 SNES VI Function norm 68.4308 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 9.167521781305e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.101349837507e+01 lambda=6.4300240519536755e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.041475585659e+01 lambda=6.6547102741568651e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.844705599568e+01 lambda=6.6547102741568653e-04 > Line search: Cubically determined step, current gnorm 6.839121015135e+01 lambda=1.4965127147397144e-04 > 6 SNES Function norm 6.839121015135e+01 > 6 SNES VI Function norm 68.5745 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 3 > Line search: gnorm after quadratic fit 9.587731188484e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.197287845440e+01 lambda=5.2775823101139679e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.940305546680e+01 lambda=5.2775823101139686e-03 > Line search: Cubically determined step, current gnorm 6.837177518619e+01 lambda=6.3969948101878912e-04 > 7 SNES Function norm 6.837177518619e+01 > 7 SNES VI Function norm 71.0652 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 3 > Line search: gnorm after quadratic fit 9.548865181502e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.876974019161e+01 lambda=5.0026957605696178e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.891985531663e+01 lambda=5.1260581886742491e-03 > Line search: Cubically determined step, current gnorm 6.832012833110e+01 lambda=9.3300874565775075e-04 > 8 SNES Function norm 6.832012833110e+01 > 8 SNES VI Function norm 79.8569 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 4 > Line search: gnorm after quadratic fit 9.541909192352e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.493349067288e+01 lambda=5.1388541796399699e-02 > Line search: Cubically determined step, current gnorm 6.781311229195e+01 lambda=7.6704381452756282e-03 > 9 SNES Function norm 6.781311229195e+01 > 9 SNES VI Function norm 206.467 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 6 > Line search: gnorm after quadratic fit 9.394254710662e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.306526091645e+01 lambda=5.3539445292607950e-02 > Line search: Cubically determined step, current gnorm 6.721835250392e+01 lambda=9.5561464381222188e-03 > 10 SNES Function norm 6.721835250392e+01 > 10 SNES VI Function norm 368.277 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 7 > Line search: gnorm after quadratic fit 9.387716261564e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.070868333837e+01 lambda=4.9443994240769853e-02 > Line search: Cubically determined step, current gnorm 6.660967991379e+01 lambda=1.0810468882260445e-02 > 11 SNES Function norm 6.660967991379e+01 > 11 SNES VI Function norm 567.089 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 9 > Line search: gnorm after quadratic fit 9.346306901087e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.048649174104e+01 lambda=4.9192073733008407e-02 > Line search: Cubically determined step, current gnorm 6.608645472517e+01 lambda=1.0044112192046832e-02 > 12 SNES Function norm 6.608645472517e+01 > 12 SNES VI Function norm 734.752 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 8 > Line search: gnorm after quadratic fit 9.452595067062e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.208837086000e+01 lambda=4.5128845776024190e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.800731174084e+01 lambda=6.5132735322282484e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.634685717588e+01 lambda=6.5132735322282484e-04 > Line search: Cubically determined step, current gnorm 6.608637269301e+01 lambda=6.5132735322282487e-05 > 13 SNES Function norm 6.608637269301e+01 > 13 SNES VI Function norm 735.814 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 8 > Line search: gnorm after quadratic fit 9.318693996551e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.139943393009e+01 lambda=4.8118075850982413e-02 > Line search: Cubically determined step, current gnorm 6.568600823304e+01 lambda=7.8756632431255542e-03 > 14 SNES Function norm 6.568600823304e+01 > 14 SNES VI Function norm 881.479 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 9 > Line search: gnorm after quadratic fit 9.242424276014e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.226307852468e+01 lambda=4.8021995541678457e-02 > Line search: Cubically determined step, current gnorm 6.540144178550e+01 lambda=6.6931701304969058e-03 > 15 SNES Function norm 6.540144178550e+01 > 15 SNES VI Function norm 1006.28 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.154992244384e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.122067564574e+01 lambda=5.0277415210907568e-02 > Line search: Cubically determined step, current gnorm 6.506969399500e+01 lambda=7.8660529387648906e-03 > 16 SNES Function norm 6.506969399500e+01 > 16 SNES VI Function norm 1131.4 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.263744099217e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.045825559590e+01 lambda=4.3976587783298791e-02 > Line search: Cubically determined step, current gnorm 6.477740872258e+01 lambda=6.6653314620139965e-03 > 17 SNES Function norm 6.477740872258e+01 > 17 SNES VI Function norm 1252.29 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.034042193429e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.097176730586e+01 lambda=4.9082849797732621e-02 > Line search: Cubically determined step, current gnorm 6.448770943479e+01 lambda=7.1730414269226593e-03 > 18 SNES Function norm 6.448770943479e+01 > 18 SNES VI Function norm 1371.72 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.028256513212e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.990381886066e+01 lambda=4.4193294185915478e-02 > Line search: Cubically determined step, current gnorm 6.422123220407e+01 lambda=6.6250183714544201e-03 > 19 SNES Function norm 6.422123220407e+01 > 19 SNES VI Function norm 1490.87 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.908334154738e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.060161630260e+01 lambda=4.6452357120490895e-02 > Line search: Cubically determined step, current gnorm 6.411445689017e+01 lambda=6.3417192629449783e-03 > 20 SNES Function norm 6.411445689017e+01 > 20 SNES VI Function norm 1597.29 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.460267552084e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.051195181220e+01 lambda=5.8933530173091400e-02 > Line search: Cubically determined step, current gnorm 6.379276529842e+01 lambda=9.2451193719573169e-03 > 21 SNES Function norm 6.379276529842e+01 > 21 SNES VI Function norm 1729.35 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.847710713735e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.007434740347e+01 lambda=4.8620669909360585e-02 > Line search: Cubically determined step, current gnorm 6.358026444281e+01 lambda=6.8922394760267177e-03 > 22 SNES Function norm 6.358026444281e+01 > 22 SNES VI Function norm 1849.77 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.435581241699e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.335475468652e+01 lambda=3.2814238215953598e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.652843583618e+01 lambda=3.2814238215953598e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.529985391051e+01 lambda=3.2814238215953602e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.366726270581e+01 lambda=3.2814238215953603e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.358115196460e+01 lambda=3.2814238215953603e-06 > Line search: Cubically determined step, current gnorm 6.358025861312e+01 lambda=3.2814238215953605e-07 > 23 SNES Function norm 6.358025861312e+01 > 23 SNES VI Function norm 1849.78 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.812900895448e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.822426303212e+01 lambda=4.8421685266110105e-02 > Line search: Cubically determined step, current gnorm 6.335842666537e+01 lambda=8.4588034499471741e-03 > 24 SNES Function norm 6.335842666537e+01 > 24 SNES VI Function norm 1993.6 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.094159193064e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.742173830047e+01 lambda=4.3243453252109078e-02 > Line search: Cubically determined step, current gnorm 6.316236273224e+01 lambda=7.7494584282214512e-03 > 25 SNES Function norm 6.316236273224e+01 > 25 SNES VI Function norm 2126.62 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.160540289460e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.722886652974e+01 lambda=4.1792497999647044e-02 > Line search: Cubically determined step, current gnorm 6.300020419956e+01 lambda=7.3335939016311632e-03 > 26 SNES Function norm 6.300020419956e+01 > 26 SNES VI Function norm 2252.12 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.890109786397e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.686097246249e+01 lambda=4.7041389395739201e-02 > Line search: Cubically determined step, current gnorm 6.283084254493e+01 lambda=9.0792221408297433e-03 > 27 SNES Function norm 6.283084254493e+01 > 27 SNES VI Function norm 2404.84 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.998798828268e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.576469464321e+01 lambda=4.2887406731046039e-02 > Line search: Cubically determined step, current gnorm 6.266968273817e+01 lambda=9.2948647727201898e-03 > 28 SNES Function norm 6.266968273817e+01 > 28 SNES VI Function norm 2558.11 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.199146621649e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.564298288247e+01 lambda=4.0193768728643060e-02 > Line search: Cubically determined step, current gnorm 6.252861090423e+01 lambda=8.3932894622200105e-03 > 29 SNES Function norm 6.252861090423e+01 > 29 SNES VI Function norm 2698.56 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.382191898563e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.772162800128e+01 lambda=3.5914901407691102e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.485302824556e+01 lambda=4.7901702628153379e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.285215446174e+01 lambda=4.7901702628153379e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.253029194340e+01 lambda=4.7901702628153380e-05 > Line search: Cubically determined step, current gnorm 6.252812967035e+01 lambda=1.5127710264417741e-05 > 30 SNES Function norm 6.252812967035e+01 > 30 SNES VI Function norm 2698.83 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.118652411357e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.495202040381e+01 lambda=4.0596953253201326e-02 > Line search: Cubically determined step, current gnorm 6.239041273754e+01 lambda=9.5128837682561859e-03 > 31 SNES Function norm 6.239041273754e+01 > 31 SNES VI Function norm 2854.38 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.077825361440e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.467284344645e+01 lambda=4.0583557291813177e-02 > Line search: Cubically determined step, current gnorm 6.225884047363e+01 lambda=9.7846838097028124e-03 > 32 SNES Function norm 6.225884047363e+01 > 32 SNES VI Function norm 3012.55 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.920999190500e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.466103609666e+01 lambda=4.2498592612658738e-02 > Line search: Cubically determined step, current gnorm 6.213582712328e+01 lambda=1.0171220001350099e-02 > 33 SNES Function norm 6.213582712328e+01 > 33 SNES VI Function norm 3175.23 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.011924620812e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.495110751676e+01 lambda=4.2453491229013124e-02 > Line search: Cubically determined step, current gnorm 6.201636649414e+01 lambda=9.3685443832871688e-03 > 34 SNES Function norm 6.201636649414e+01 > 34 SNES VI Function norm 3322.22 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.006024690051e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.414041989575e+01 lambda=4.0940226638739433e-02 > Line search: Cubically determined step, current gnorm 6.190218472271e+01 lambda=1.0273994032172384e-02 > 35 SNES Function norm 6.190218472271e+01 > 35 SNES VI Function norm 3484.25 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.898991234613e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.426189506521e+01 lambda=4.3426020819675164e-02 > Line search: Cubically determined step, current gnorm 6.178678684779e+01 lambda=1.0559984512509757e-02 > 36 SNES Function norm 6.178678684779e+01 > 36 SNES VI Function norm 3648.36 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.648025040907e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.404650680722e+01 lambda=4.6749921483990771e-02 > Line search: Cubically determined step, current gnorm 6.165099494681e+01 lambda=1.1866483746353381e-02 > 37 SNES Function norm 6.165099494681e+01 > 37 SNES VI Function norm 3822.88 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.858076523292e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.520416756669e+01 lambda=4.2063577748779259e-02 > Line search: Cubically determined step, current gnorm 6.152598711257e+01 lambda=7.9475995139781722e-03 > 38 SNES Function norm 6.152598711257e+01 > 38 SNES VI Function norm 3944.22 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.742192022113e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.343055909293e+01 lambda=3.8810591937350140e-02 > Line search: Cubically determined step, current gnorm 6.135131913134e+01 lambda=9.8750504088198892e-03 > 39 SNES Function norm 6.135131913134e+01 > 39 SNES VI Function norm 4066.15 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.286112632409e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.061265007302e+01 lambda=2.9694426041134040e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.436749315348e+01 lambda=2.9694426041134044e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.299789903123e+01 lambda=2.9694426041134044e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141298285103e+01 lambda=2.9694426041134044e-05 > Line search: Cubically determined step, current gnorm 6.135130530880e+01 lambda=2.9694426041134044e-06 > 40 SNES Function norm 6.135130530880e+01 > 40 SNES VI Function norm 4066.23 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.660062754407e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.674944119178e+01 lambda=4.3170190544802138e-02 > Line search: Cubically determined step, current gnorm 6.120973541057e+01 lambda=6.1770273873522300e-03 > 41 SNES Function norm 6.120973541057e+01 > 41 SNES VI Function norm 4152.83 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.564645091492e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676153862982e+01 lambda=4.4220462778047379e-02 > Line search: Cubically determined step, current gnorm 6.104393345352e+01 lambda=6.3589031499342100e-03 > 42 SNES Function norm 6.104393345352e+01 > 42 SNES VI Function norm 4233.82 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.368658054045e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.715427252993e+01 lambda=4.7003756543045970e-02 > Line search: Cubically determined step, current gnorm 6.101753259623e+01 lambda=6.3787492486959132e-03 > 43 SNES Function norm 6.101753259623e+01 > 43 SNES VI Function norm 4314.49 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.442307716417e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.496496980051e+01 lambda=4.5726539795380154e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.142635208964e+01 lambda=8.4157732414286580e-03 > Line search: Cubically determined step, current gnorm 6.095430498328e+01 lambda=2.1294466610363495e-03 > 44 SNES Function norm 6.095430498328e+01 > 44 SNES VI Function norm 4341.47 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 12 > Line search: gnorm after quadratic fit 8.439891204437e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.240254752159e+01 lambda=4.3289599290802970e-02 > Line search: Cubically determined step, current gnorm 6.081365387079e+01 lambda=1.2916446928212236e-02 > 45 SNES Function norm 6.081365387079e+01 > 45 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.664056729635e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.944851102419e+01 lambda=1.8635858087631831e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.394837998027e+01 lambda=1.8635858087631832e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.278442438314e+01 lambda=1.8635858087631834e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.093400706607e+01 lambda=1.8635858087631834e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081489139942e+01 lambda=1.8635858087631835e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365630503e+01 lambda=1.8635858087631836e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365482998e+01 lambda=7.3438624052552081e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365418254e+01 lambda=2.3870801624167493e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365397577e+01 lambda=8.0330117961387493e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365390593e+01 lambda=2.6874115312641255e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388261e+01 lambda=8.9982494953058537e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387467e+01 lambda=3.0083351315759278e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387219e+01 lambda=1.0110298276678126e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387129e+01 lambda=3.3292703628714462e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387093e+01 lambda=1.0739379834615402e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=3.6237724732408161e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=1.2456833192766385e-12 > Line search: Cubically determined step, current gnorm 6.081365387079e+01 lambda=3.5247146389212346e-13 > 46 SNES Function norm 6.081365387079e+01 > 46 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 1.433547268242e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.106740636849e+01 lambda=2.4859604812085913e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.525497375887e+01 lambda=7.2498301889276232e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367730849091e+01 lambda=7.2498301889276236e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.174333248068e+01 lambda=7.2498301889276242e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.083400168850e+01 lambda=7.2498301889276242e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081378891362e+01 lambda=7.2498301889276242e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365527548e+01 lambda=1.0753239548189211e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365445012e+01 lambda=4.4350670800939511e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365407923e+01 lambda=1.5953160232199837e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365394762e+01 lambda=5.8822684037182187e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365389903e+01 lambda=2.1599843490971948e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388111e+01 lambda=7.9357831777119289e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387457e+01 lambda=2.9181178721013368e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387223e+01 lambda=1.0733281860745436e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387132e+01 lambda=3.9236995040615546e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387106e+01 lambda=1.4351792294805992e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387081e+01 lambda=4.8683006404131606e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387087e+01 lambda=2.0863028416245319e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387080e+01 lambda=5.3058618006527772e-13 > Line search: unable to find good step length! After 19 tries > Line search: fnorm=6.0813653870787959e+01, gnorm=6.0813653870799314e+01, ynorm=7.0504021074247237e+02, minlambda=9.9999999999999998e-13, lambda=5.3058618006527772e-13, initial slope=-4.7232673282579080e+03 > 47 SNES Function norm 6.081365387079e+01 > 47 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 1.280890413731e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.053050135324e+01 lambda=2.2733898438250671e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.399979736493e+01 lambda=2.2733898438250673e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.297299206174e+01 lambda=2.2733898438250674e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.098427084652e+01 lambda=2.2733898438250677e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081555475063e+01 lambda=2.2733898438250679e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365745105e+01 lambda=2.2733898438250681e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365507363e+01 lambda=9.2077672155667702e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365429323e+01 lambda=3.2329991301020441e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365402243e+01 lambda=1.1595563414967544e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365392495e+01 lambda=4.1432803927719340e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365389024e+01 lambda=1.4815603373453140e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387781e+01 lambda=5.2922825349649990e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387324e+01 lambda=1.8866396505817014e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387173e+01 lambda=6.7568116386381729e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387107e+01 lambda=2.3800109593117919e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387094e+01 lambda=8.6880387507986266e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=2.8858967256610185e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=1.0348935437400166e-12 > Line search: Cubically determined step, current gnorm 6.081365387077e+01 lambda=2.7070538024707468e-13 > 48 SNES Function norm 6.081365387077e+01 > 48 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 1.170943716019e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.038597782185e+01 lambda=2.2207476459146142e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.399318571001e+01 lambda=2.2207476459146142e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.295164029113e+01 lambda=2.2207476459146143e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.097743654776e+01 lambda=2.2207476459146143e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081546079136e+01 lambda=2.2207476459146144e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365719872e+01 lambda=2.2207476459146145e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365503919e+01 lambda=9.0117449908413481e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365427749e+01 lambda=3.1364523245356123e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365401596e+01 lambda=1.1183735694685806e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365392232e+01 lambda=3.9706025565052754e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388909e+01 lambda=1.4107330444508480e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387724e+01 lambda=5.0110371464381371e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387308e+01 lambda=1.7820909495605996e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387164e+01 lambda=6.3314737242538209e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387114e+01 lambda=2.2207910898013729e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387085e+01 lambda=7.4515329000007742e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=2.7872933392432575e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=8.8269934321345058e-13 > Line search: unable to find good step length! After 18 tries > Line search: fnorm=6.0813653870766274e+01, gnorm=6.0813653870831025e+01, ynorm=7.0578565675503091e+02, minlambda=9.9999999999999998e-13, lambda=8.8269934321345058e-13, initial slope=-3.8123379550451641e+03 > Nonlinear solve did not converge due to DIVERGED_LINE_SEARCH iterations 48 > > Amir > > On Aug 18 2018, at 11:42 pm, Smith, Barry F. wrote: > > > -snes_monitor -snes_linesearch_monitor -pc_type lu > > produces what? > > Barry > > The line search failing means that the direction computed is not a descent direction which could be due to a bad Jacobian or inconsistent constraints. > > > On Aug 17, 2018, at 11:56 PM, Amir wrote: > > Hi > I need to apply constraint to primitive variables. I am troubling to set up SNESVI. After running the code, I feel SNES is not actually solving. After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in function norm. > I think the way I set VI maybe wrong. Sorry for my simple explanation. > Very thankful for your time. > Amir > SNESCreate(PETSC_COMM_WORLD,&snes); > SNESSetApplicationContext(snes,&user); > SNESSetDM(snes,user.dm); > SNESSetFunction(snes,NULL,FormFunction,&user); > FormInitialSolution(user.X,&user); > SNESSetSolution(snes,user.X); > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > SNESSetType(snes,SNESVINEWTONSSLS); > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > SNESGetLineSearch(snes,&linesearch); > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > SNESSetFromOptions(snes); > SNESSolve(snes,NULL,user.X); > From bsmith at mcs.anl.gov Sun Aug 19 16:14:46 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Sun, 19 Aug 2018 21:14:46 +0000 Subject: [petsc-users] [petsc-maint] an error message related to nest matrix In-Reply-To: References: Message-ID: Mike, Sorry for the delay in responding, thanks for the error report. It was a bug in our use of VecGetArray/VecRestoreArray() in our VecScatter routines. I have fixed it in the branch barry/fix-vecgetarrayscatter and your example should run correctly on the branch with no memory error. Barry > On Aug 14, 2018, at 12:19 PM, Mike Wick wrote: > > Hi: > > I have a simple code myself to learn the basic usage of nest matrix. It assembles a 3x3 nest matrix and solve with that nest matrix. I can run it without a preconditioner. Running the code with -pc_type fieldsplit just leads to an error message. I have no clue of what goes wrong. The message is in below. I also have my code attached. > > Thanks, > > M > > [0]PETSC ERROR: PetscTrFreeDefault() called from VecRestoreArray_Nest() line 678 in /home/lib/petsc-3.9.1-src/src/vec/vec/impls/nest/vecnest.c > [0]PETSC ERROR: Block at address 0x2784ec8 is corrupted; cannot free; > may be block not allocated with PetscMalloc() > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Memory corruption: http://www.mcs.anl.gov/petsc/documentation/installation.html#valgrind > [0]PETSC ERROR: Bad location or corrupted memory > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Release Version 3.9.1, Apr, 29, 2018 > [0]PETSC ERROR: ./matnest on a named bacon by mike Tue Aug 14 10:03:56 2018 > [0]PETSC ERROR: Configure options --with-x=0 -with-pic --with-make-np=12 --with-mpi-compilers=1 --with-mpi-dir=/home/lib/mpich-3.2/ --with-scalar-type=real --with-shared-libraries=1 --with-precision=double --with-chaco=1 --download-chaco --with-hypre=1 --download-hypre --with-plapack=1 --download-plapack --with-spai=1 --download-spai --with-sundials=1 --download-sundials --with-mumps=1 --download-mumps --with-scalapack=1 --download-scalapack --with-blacs=1 --download-blacs --with-spooles=1 --download-spooles --with-suitesparse=1 --download-suitesparse --with-superlu_dist=1 --download-superlu_dist --with-superlu=1 --download-superlu --with-zoltan=1 --download-zoltan=1 --with-debugging=yes --download-fblaslapack --with-ml=1 --download-ml --with-eigen=1 --download-eigen --prefix=~/lib/petsc-3.9.1-debug > [0]PETSC ERROR: #1 PetscTrFreeDefault() line 269 in /home/lib/petsc-3.9.1-src/src/sys/memory/mtr.c > [0]PETSC ERROR: #2 VecRestoreArray_Nest() line 678 in /home/lib/petsc-3.9.1-src/src/vec/vec/impls/nest/vecnest.c > [0]PETSC ERROR: #3 VecRestoreArrayRead() line 1835 in /home/lib/petsc-3.9.1-src/src/vec/vec/interface/rvector.c > [0]PETSC ERROR: #4 VecRestoreArrayPair() line 511 in /home/lib/petsc-3.9.1-src/include/petscvec.h > [0]PETSC ERROR: #5 VecScatterBegin_SSToSS() line 671 in /home/lib/petsc-3.9.1-src/src/vec/vscat/impls/vscat.c > [0]PETSC ERROR: #6 VecScatterBegin() line 1779 in /home/lib/petsc-3.9.1-src/src/vec/vscat/impls/vscat.c > [0]PETSC ERROR: #7 PCApply_FieldSplit() line 1040 in /home/lib/petsc-3.9.1-src/src/ksp/pc/impls/fieldsplit/fieldsplit.c > [0]PETSC ERROR: #8 PCApply() line 457 in /home/lib/petsc-3.9.1-src/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: #9 KSP_PCApply() line 276 in /home/lib/petsc-3.9.1-src/include/petsc/private/kspimpl.h > [0]PETSC ERROR: #10 KSPInitialResidual() line 67 in /home/lib/petsc-3.9.1-src/src/ksp/ksp/interface/itres.c > [0]PETSC ERROR: #11 KSPSolve_GMRES() line 233 in /home/lib/petsc-3.9.1-src/src/ksp/ksp/impls/gmres/gmres.c > [0]PETSC ERROR: #12 KSPSolve() line 669 in /home/lib/petsc-3.9.1-src/src/ksp/ksp/interface/itfunc.c > From a.croucher at auckland.ac.nz Sun Aug 19 20:51:58 2018 From: a.croucher at auckland.ac.nz (Adrian Croucher) Date: Mon, 20 Aug 2018 13:51:58 +1200 Subject: [petsc-users] v3.9.3 config problem Message-ID: <88062aed-0fc8-c891-3f73-65858406b916@auckland.ac.nz> hi I just pulled the latest PETSc master branch (v3.9.3) but am having trouble building it. It's been running fine on v3.8.4. I deleted my $PETSC_ARCH directory and tried to configure. But it seems to be falling over when trying to build Exodus. I've attached the configure.log. Any ideas? - Adrian -- Dr Adrian Croucher Senior Research Fellow Department of Engineering Science University of Auckland, New Zealand email: a.croucher at auckland.ac.nz tel: +64 (0)9 923 4611 -------------- next part -------------- A non-text attachment was scrubbed... Name: configure.log Type: text/x-log Size: 3377489 bytes Desc: not available URL: From bsmith at mcs.anl.gov Sun Aug 19 21:00:10 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Mon, 20 Aug 2018 02:00:10 +0000 Subject: [petsc-users] v3.9.3 config problem In-Reply-To: <88062aed-0fc8-c891-3f73-65858406b916@auckland.ac.nz> References: <88062aed-0fc8-c891-3f73-65858406b916@auckland.ac.nz> Message-ID: <19461756-1DE5-4E3C-8EA1-7AB65F777AE7@anl.gov> Trying to reproduce it now but I'm pretty sure we've tested it. Do you have some old files lying around that might be causing the problem? /home/acro018/software/PETSc/code/linux-gnu-c-opt/externalpackages/git.exodusii/packages/seacas/libraries/exodus/src/ex_create_par.c:375:9: error: 'netcdf4_mode' undeclared (first use in this function) if (netcdf4_mode == -1) { Maybe externalpackages has downloads from a previous build still located that don't work with the latest exodusii? Barry > On Aug 19, 2018, at 8:51 PM, Adrian Croucher wrote: > > hi > > I just pulled the latest PETSc master branch (v3.9.3) but am having trouble building it. It's been running fine on v3.8.4. > > I deleted my $PETSC_ARCH directory and tried to configure. But it seems to be falling over when trying to build Exodus. I've attached the configure.log. > > Any ideas? > > - Adrian > > -- > Dr Adrian Croucher > Senior Research Fellow > Department of Engineering Science > University of Auckland, New Zealand > email: a.croucher at auckland.ac.nz > tel: +64 (0)9 923 4611 > > From a.croucher at auckland.ac.nz Sun Aug 19 21:01:31 2018 From: a.croucher at auckland.ac.nz (Adrian Croucher) Date: Mon, 20 Aug 2018 14:01:31 +1200 Subject: [petsc-users] v3.9.3 config problem In-Reply-To: <19461756-1DE5-4E3C-8EA1-7AB65F777AE7@anl.gov> References: <88062aed-0fc8-c891-3f73-65858406b916@auckland.ac.nz> <19461756-1DE5-4E3C-8EA1-7AB65F777AE7@anl.gov> Message-ID: <4ccdfb55-4197-4c3e-967f-26e1cc6ee96c@auckland.ac.nz> Should I try wiping out the externalpackages directory as well as $PETSC_ARCH? - Adrian On 20/08/18 14:00, Smith, Barry F. wrote: > Trying to reproduce it now but I'm pretty sure we've tested it. > > Do you have some old files lying around that might be causing the problem? > > /home/acro018/software/PETSc/code/linux-gnu-c-opt/externalpackages/git.exodusii/packages/seacas/libraries/exodus/src/ex_create_par.c:375:9: error: 'netcdf4_mode' undeclared (first use in this function) > if (netcdf4_mode == -1) { > > Maybe externalpackages has downloads from a previous build still located that don't work with the latest exodusii? > > > Barry > > > > >> On Aug 19, 2018, at 8:51 PM, Adrian Croucher wrote: >> >> hi >> >> I just pulled the latest PETSc master branch (v3.9.3) but am having trouble building it. It's been running fine on v3.8.4. >> >> I deleted my $PETSC_ARCH directory and tried to configure. But it seems to be falling over when trying to build Exodus. I've attached the configure.log. >> >> Any ideas? >> >> - Adrian >> >> -- >> Dr Adrian Croucher >> Senior Research Fellow >> Department of Engineering Science >> University of Auckland, New Zealand >> email: a.croucher at auckland.ac.nz >> tel: +64 (0)9 923 4611 >> >> -- Dr Adrian Croucher Senior Research Fellow Department of Engineering Science University of Auckland, New Zealand email: a.croucher at auckland.ac.nz tel: +64 (0)9 923 4611 From bsmith at mcs.anl.gov Sun Aug 19 21:05:08 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Mon, 20 Aug 2018 02:05:08 +0000 Subject: [petsc-users] v3.9.3 config problem In-Reply-To: <4ccdfb55-4197-4c3e-967f-26e1cc6ee96c@auckland.ac.nz> References: <88062aed-0fc8-c891-3f73-65858406b916@auckland.ac.nz> <19461756-1DE5-4E3C-8EA1-7AB65F777AE7@anl.gov> <4ccdfb55-4197-4c3e-967f-26e1cc6ee96c@auckland.ac.nz> Message-ID: <06B5ECF1-331D-4D61-9842-D7BFF13F1911@mcs.anl.gov> I can reproduce the problem so don't bother wiping anything just yet. My compiler gives more useful messages: s/src/ex_create_par.c:388:16: error: use of undeclared identifier 'netcdf4_mode'; did you mean 'netcdf5_mode'? nc_mode |= netcdf4_mode; ^~~~~~~~~~~~ netcdf5_mode So it appears that the exodusii version used requires a more recent version of netcdf but why didn't our testing detect this???? > On Aug 19, 2018, at 9:01 PM, Adrian Croucher wrote: > > Should I try wiping out the externalpackages directory as well as $PETSC_ARCH? > > - Adrian > > On 20/08/18 14:00, Smith, Barry F. wrote: >> Trying to reproduce it now but I'm pretty sure we've tested it. >> >> Do you have some old files lying around that might be causing the problem? >> >> /home/acro018/software/PETSc/code/linux-gnu-c-opt/externalpackages/git.exodusii/packages/seacas/libraries/exodus/src/ex_create_par.c:375:9: error: 'netcdf4_mode' undeclared (first use in this function) >> if (netcdf4_mode == -1) { >> >> Maybe externalpackages has downloads from a previous build still located that don't work with the latest exodusii? >> >> >> Barry >> >> >> >> >>> On Aug 19, 2018, at 8:51 PM, Adrian Croucher wrote: >>> >>> hi >>> >>> I just pulled the latest PETSc master branch (v3.9.3) but am having trouble building it. It's been running fine on v3.8.4. >>> >>> I deleted my $PETSC_ARCH directory and tried to configure. But it seems to be falling over when trying to build Exodus. I've attached the configure.log. >>> >>> Any ideas? >>> >>> - Adrian >>> >>> -- >>> Dr Adrian Croucher >>> Senior Research Fellow >>> Department of Engineering Science >>> University of Auckland, New Zealand >>> email: a.croucher at auckland.ac.nz >>> tel: +64 (0)9 923 4611 >>> >>> > > -- > Dr Adrian Croucher > Senior Research Fellow > Department of Engineering Science > University of Auckland, New Zealand > email: a.croucher at auckland.ac.nz > tel: +64 (0)9 923 4611 > From a.croucher at auckland.ac.nz Sun Aug 19 21:06:37 2018 From: a.croucher at auckland.ac.nz (Adrian Croucher) Date: Mon, 20 Aug 2018 14:06:37 +1200 Subject: [petsc-users] v3.9.3 config problem In-Reply-To: <4ccdfb55-4197-4c3e-967f-26e1cc6ee96c@auckland.ac.nz> References: <88062aed-0fc8-c891-3f73-65858406b916@auckland.ac.nz> <19461756-1DE5-4E3C-8EA1-7AB65F777AE7@anl.gov> <4ccdfb55-4197-4c3e-967f-26e1cc6ee96c@auckland.ac.nz> Message-ID: <4109684b-6367-2ddb-e160-e39f657062e9@auckland.ac.nz> On 20/08/18 14:01, Adrian Croucher wrote: > Should I try wiping out the externalpackages directory as well as > $PETSC_ARCH? I did try this anyway. First it gave the following errors: Error! missing file: /home/acro018/software/PETSc/code/externalpackages-bak/sowing-1.1.16d/src/sys/makefile Error! missing file: /home/acro018/software/PETSc/code/externalpackages-bak/sowing-1.1.16d/src/doctext/test/makefile Error! missing file: /home/acro018/software/PETSc/code/externalpackages-bak/sowing-1.1.16d/src/bfort/testing/makefile Not sure if these matter. It continued but then got the same errors trying to build Exodus. - Adrian > > - Adrian > > On 20/08/18 14:00, Smith, Barry F. wrote: >> ??? Trying to reproduce it now but I'm pretty sure we've tested it. >> >> ??? Do you have some old files lying around that might be causing the >> problem? >> >> /home/acro018/software/PETSc/code/linux-gnu-c-opt/externalpackages/git.exodusii/packages/seacas/libraries/exodus/src/ex_create_par.c:375:9: >> error: 'netcdf4_mode' undeclared (first use in this function) >> ????? if (netcdf4_mode == -1) { >> >> Maybe externalpackages has downloads from a previous build still >> located that don't work with the latest exodusii? >> >> >> ??? Barry >> >> >> >> >>> On Aug 19, 2018, at 8:51 PM, Adrian Croucher >>> wrote: >>> >>> hi >>> >>> I just pulled the latest PETSc master branch (v3.9.3) but am having >>> trouble building it. It's been running fine on v3.8.4. >>> >>> I deleted my $PETSC_ARCH directory and tried to configure. But it >>> seems to be falling over when trying to build Exodus. I've attached >>> the configure.log. >>> >>> Any ideas? >>> >>> - Adrian >>> >>> -- >>> Dr Adrian Croucher >>> Senior Research Fellow >>> Department of Engineering Science >>> University of Auckland, New Zealand >>> email: a.croucher at auckland.ac.nz >>> tel: +64 (0)9 923 4611 >>> >>> > -- Dr Adrian Croucher Senior Research Fellow Department of Engineering Science University of Auckland, New Zealand email: a.croucher at auckland.ac.nz tel: +64 (0)9 923 4611 From bsmith at mcs.anl.gov Sun Aug 19 21:13:10 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Mon, 20 Aug 2018 02:13:10 +0000 Subject: [petsc-users] v3.9.3 config problem In-Reply-To: <06B5ECF1-331D-4D61-9842-D7BFF13F1911@mcs.anl.gov> References: <88062aed-0fc8-c891-3f73-65858406b916@auckland.ac.nz> <19461756-1DE5-4E3C-8EA1-7AB65F777AE7@anl.gov> <4ccdfb55-4197-4c3e-967f-26e1cc6ee96c@auckland.ac.nz> <06B5ECF1-331D-4D61-9842-D7BFF13F1911@mcs.anl.gov> Message-ID: The ftp site with the version 4 netcfd files does have an that look like version 5. Have to keep looking for netcdf 5 (assuming it must exist). Barry > On Aug 19, 2018, at 9:05 PM, Smith, Barry F. wrote: > > > I can reproduce the problem so don't bother wiping anything just yet. My compiler gives more useful messages: > > s/src/ex_create_par.c:388:16: error: use of undeclared identifier 'netcdf4_mode'; did you mean 'netcdf5_mode'? > nc_mode |= netcdf4_mode; > ^~~~~~~~~~~~ > netcdf5_mode > > So it appears that the exodusii version used requires a more recent version of netcdf but why didn't our testing detect this???? > > > >> On Aug 19, 2018, at 9:01 PM, Adrian Croucher wrote: >> >> Should I try wiping out the externalpackages directory as well as $PETSC_ARCH? >> >> - Adrian >> >> On 20/08/18 14:00, Smith, Barry F. wrote: >>> Trying to reproduce it now but I'm pretty sure we've tested it. >>> >>> Do you have some old files lying around that might be causing the problem? >>> >>> /home/acro018/software/PETSc/code/linux-gnu-c-opt/externalpackages/git.exodusii/packages/seacas/libraries/exodus/src/ex_create_par.c:375:9: error: 'netcdf4_mode' undeclared (first use in this function) >>> if (netcdf4_mode == -1) { >>> >>> Maybe externalpackages has downloads from a previous build still located that don't work with the latest exodusii? >>> >>> >>> Barry >>> >>> >>> >>> >>>> On Aug 19, 2018, at 8:51 PM, Adrian Croucher wrote: >>>> >>>> hi >>>> >>>> I just pulled the latest PETSc master branch (v3.9.3) but am having trouble building it. It's been running fine on v3.8.4. >>>> >>>> I deleted my $PETSC_ARCH directory and tried to configure. But it seems to be falling over when trying to build Exodus. I've attached the configure.log. >>>> >>>> Any ideas? >>>> >>>> - Adrian >>>> >>>> -- >>>> Dr Adrian Croucher >>>> Senior Research Fellow >>>> Department of Engineering Science >>>> University of Auckland, New Zealand >>>> email: a.croucher at auckland.ac.nz >>>> tel: +64 (0)9 923 4611 >>>> >>>> >> >> -- >> Dr Adrian Croucher >> Senior Research Fellow >> Department of Engineering Science >> University of Auckland, New Zealand >> email: a.croucher at auckland.ac.nz >> tel: +64 (0)9 923 4611 >> > From mhbaghaei at mail.sjtu.edu.cn Sun Aug 19 22:12:10 2018 From: mhbaghaei at mail.sjtu.edu.cn (Amir) Date: Mon, 20 Aug 2018 11:12:10 +0800 Subject: [petsc-users] Setting SNESVI In-Reply-To: <4CB90C24-E326-43CE-B562-5371BB2092E3@mcs.anl.gov> References: <4CB90C24-E326-43CE-B562-5371BB2092E3@mcs.anl.gov> Message-ID: <1534734601.local-6a947c4f-71fe-v1.4.2-f587b7b7@getmailspring.com> I just put the constraint at the PETSC_INFINITY, this is what I get, which is the same as when I use NEWTONLS: 0 SNES Function norm 6.839972031896e+01 0 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: gnorm after quadratic fit 6.231294332518e+01 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 1 SNES Function norm 6.231294332518e+01 1 SNES VI Function norm 62.3129 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: gnorm after quadratic fit 5.677271460653e+01 Line search: Quadratically determined step, lambda=1.0000000000000001e-01 2 SNES Function norm 5.677271460653e+01 2 SNES VI Function norm 56.7727 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: gnorm after quadratic fit 4.945867427788e+01 Line search: Quadratically determined step, lambda=1.5314449290174556e-01 3 SNES Function norm 4.945867427788e+01 3 SNES VI Function norm 49.4587 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: gnorm after quadratic fit 3.912546059379e+01 Line search: Quadratically determined step, lambda=2.8355714983096392e-01 4 SNES Function norm 3.912546059379e+01 4 SNES VI Function norm 39.1255 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: Using full step: fnorm 3.912546059379e+01 gnorm 3.171372000187e+01 5 SNES Function norm 3.171372000187e+01 5 SNES VI Function norm 31.7137 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: Using full step: fnorm 3.171372000187e+01 gnorm 1.036076366647e-01 6 SNES Function norm 1.036076366647e-01 6 SNES VI Function norm 0.103608 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Linear solve converged due to CONVERGED_RTOL iterations 2 Line search: Using full step: fnorm 1.036076366647e-01 gnorm 1.913739253850e-06 7 SNES Function norm 1.913739253850e-06 7 SNES VI Function norm 1.91374e-06 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 7 On Aug 20 2018, at 2:00 am, Smith, Barry F. wrote: > > > Note that no constraints are reached at the first iterations despite the terrible convergence. I suspect something is wrong with either the formulation or the Jacobian (that is nothing to do with the constraints). What do you get with the same options if you do not set any constraints? The same terrible convergence or something different (send it). In PETSc 3.9 you can run with the option -snes_test_jacobian to see if the Jacobians are accurate or out of whack. > Barry > > > On Aug 19, 2018, at 9:19 AM, Amir wrote: > > This is what I get after I modify the constraints, and using lu: > > 0 SNES Function norm 6.839975279451e+01 > > 0 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 1.167382139621e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.661035212791e+01 lambda=1.4620823686291085e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.872462383177e+01 lambda=1.4620823686291085e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.010735352812e+01 lambda=1.4620823686291087e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.845164828370e+01 lambda=1.4620823686291088e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840024692820e+01 lambda=1.4620823686291089e-06 > > Line search: Cubically determined step, current gnorm 6.839974867692e+01 lambda=1.4620823686291089e-07 > > 1 SNES Function norm 6.839974867692e+01 > > 1 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Line search: gnorm after quadratic fit 1.313376791907e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.102614855398e+02 lambda=1.4115774027030809e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 9.096517666290e+01 lambda=1.4115774027030810e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.587134084601e+01 lambda=1.4115774027030810e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.877273920434e+01 lambda=1.4115774027030810e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840408582565e+01 lambda=1.4115774027030811e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.839977811504e+01 lambda=1.4115774027030813e-07 > > Line search: Cubically determined step, current gnorm 6.839974761445e+01 lambda=1.7645101306134412e-08 > > 2 SNES Function norm 6.839974761445e+01 > > 2 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 2 > > Line search: gnorm after quadratic fit 1.053816835919e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.064875244204e+02 lambda=2.9620424834498244e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.928160190384e+01 lambda=2.9620424834498247e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.462621000022e+01 lambda=2.9620424834498249e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.862607236334e+01 lambda=2.9620424834498250e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840219410268e+01 lambda=2.9620424834498251e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.839975697009e+01 lambda=2.9620424834498251e-07 > > Line search: Cubically determined step, current gnorm 6.839974486019e+01 lambda=1.0073837635308560e-07 > > 3 SNES Function norm 6.839974486019e+01 > > 3 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 2 > > Line search: gnorm after quadratic fit 1.235990792724e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 1.013971718389e+02 lambda=2.3488863243422971e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.781731557824e+01 lambda=2.3488863243422975e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.872972483427e+01 lambda=2.3488863243422976e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840207967049e+01 lambda=2.3488863243422978e-05 > > Line search: Cubically determined step, current gnorm 6.839957781288e+01 lambda=4.7431867318372446e-06 > > 4 SNES Function norm 6.839957781288e+01 > > 4 SNES VI Function norm 68.4009 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 2 > > Line search: gnorm after quadratic fit 1.076412782767e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.067259042361e+01 lambda=2.9654955573060381e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.991099677071e+01 lambda=2.9654955573060384e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.841319422751e+01 lambda=2.9654955573060385e-04 > > Line search: Cubically determined step, current gnorm 6.839661391957e+01 lambda=8.6072251116571315e-05 > > 5 SNES Function norm 6.839661391957e+01 > > 5 SNES VI Function norm 68.4308 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 2 > > Line search: gnorm after quadratic fit 9.167521781305e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.101349837507e+01 lambda=6.4300240519536755e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.041475585659e+01 lambda=6.6547102741568651e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.844705599568e+01 lambda=6.6547102741568653e-04 > > Line search: Cubically determined step, current gnorm 6.839121015135e+01 lambda=1.4965127147397144e-04 > > 6 SNES Function norm 6.839121015135e+01 > > 6 SNES VI Function norm 68.5745 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 3 > > Line search: gnorm after quadratic fit 9.587731188484e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 8.197287845440e+01 lambda=5.2775823101139679e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.940305546680e+01 lambda=5.2775823101139686e-03 > > Line search: Cubically determined step, current gnorm 6.837177518619e+01 lambda=6.3969948101878912e-04 > > 7 SNES Function norm 6.837177518619e+01 > > 7 SNES VI Function norm 71.0652 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 3 > > Line search: gnorm after quadratic fit 9.548865181502e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.876974019161e+01 lambda=5.0026957605696178e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.891985531663e+01 lambda=5.1260581886742491e-03 > > Line search: Cubically determined step, current gnorm 6.832012833110e+01 lambda=9.3300874565775075e-04 > > 8 SNES Function norm 6.832012833110e+01 > > 8 SNES VI Function norm 79.8569 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 4 > > Line search: gnorm after quadratic fit 9.541909192352e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.493349067288e+01 lambda=5.1388541796399699e-02 > > Line search: Cubically determined step, current gnorm 6.781311229195e+01 lambda=7.6704381452756282e-03 > > 9 SNES Function norm 6.781311229195e+01 > > 9 SNES VI Function norm 206.467 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 6 > > Line search: gnorm after quadratic fit 9.394254710662e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.306526091645e+01 lambda=5.3539445292607950e-02 > > Line search: Cubically determined step, current gnorm 6.721835250392e+01 lambda=9.5561464381222188e-03 > > 10 SNES Function norm 6.721835250392e+01 > > 10 SNES VI Function norm 368.277 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 7 > > Line search: gnorm after quadratic fit 9.387716261564e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.070868333837e+01 lambda=4.9443994240769853e-02 > > Line search: Cubically determined step, current gnorm 6.660967991379e+01 lambda=1.0810468882260445e-02 > > 11 SNES Function norm 6.660967991379e+01 > > 11 SNES VI Function norm 567.089 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 9 > > Line search: gnorm after quadratic fit 9.346306901087e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.048649174104e+01 lambda=4.9192073733008407e-02 > > Line search: Cubically determined step, current gnorm 6.608645472517e+01 lambda=1.0044112192046832e-02 > > 12 SNES Function norm 6.608645472517e+01 > > 12 SNES VI Function norm 734.752 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 8 > > Line search: gnorm after quadratic fit 9.452595067062e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.208837086000e+01 lambda=4.5128845776024190e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.800731174084e+01 lambda=6.5132735322282484e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.634685717588e+01 lambda=6.5132735322282484e-04 > > Line search: Cubically determined step, current gnorm 6.608637269301e+01 lambda=6.5132735322282487e-05 > > 13 SNES Function norm 6.608637269301e+01 > > 13 SNES VI Function norm 735.814 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 8 > > Line search: gnorm after quadratic fit 9.318693996551e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.139943393009e+01 lambda=4.8118075850982413e-02 > > Line search: Cubically determined step, current gnorm 6.568600823304e+01 lambda=7.8756632431255542e-03 > > 14 SNES Function norm 6.568600823304e+01 > > 14 SNES VI Function norm 881.479 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 9 > > Line search: gnorm after quadratic fit 9.242424276014e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.226307852468e+01 lambda=4.8021995541678457e-02 > > Line search: Cubically determined step, current gnorm 6.540144178550e+01 lambda=6.6931701304969058e-03 > > 15 SNES Function norm 6.540144178550e+01 > > 15 SNES VI Function norm 1006.28 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 9.154992244384e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.122067564574e+01 lambda=5.0277415210907568e-02 > > Line search: Cubically determined step, current gnorm 6.506969399500e+01 lambda=7.8660529387648906e-03 > > 16 SNES Function norm 6.506969399500e+01 > > 16 SNES VI Function norm 1131.4 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 9.263744099217e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.045825559590e+01 lambda=4.3976587783298791e-02 > > Line search: Cubically determined step, current gnorm 6.477740872258e+01 lambda=6.6653314620139965e-03 > > 17 SNES Function norm 6.477740872258e+01 > > 17 SNES VI Function norm 1252.29 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 9.034042193429e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.097176730586e+01 lambda=4.9082849797732621e-02 > > Line search: Cubically determined step, current gnorm 6.448770943479e+01 lambda=7.1730414269226593e-03 > > 18 SNES Function norm 6.448770943479e+01 > > 18 SNES VI Function norm 1371.72 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 9.028256513212e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.990381886066e+01 lambda=4.4193294185915478e-02 > > Line search: Cubically determined step, current gnorm 6.422123220407e+01 lambda=6.6250183714544201e-03 > > 19 SNES Function norm 6.422123220407e+01 > > 19 SNES VI Function norm 1490.87 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 8.908334154738e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.060161630260e+01 lambda=4.6452357120490895e-02 > > Line search: Cubically determined step, current gnorm 6.411445689017e+01 lambda=6.3417192629449783e-03 > > 20 SNES Function norm 6.411445689017e+01 > > 20 SNES VI Function norm 1597.29 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.460267552084e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.051195181220e+01 lambda=5.8933530173091400e-02 > > Line search: Cubically determined step, current gnorm 6.379276529842e+01 lambda=9.2451193719573169e-03 > > 21 SNES Function norm 6.379276529842e+01 > > 21 SNES VI Function norm 1729.35 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 8.847710713735e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.007434740347e+01 lambda=4.8620669909360585e-02 > > Line search: Cubically determined step, current gnorm 6.358026444281e+01 lambda=6.8922394760267177e-03 > > 22 SNES Function norm 6.358026444281e+01 > > 22 SNES VI Function norm 1849.77 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 9.435581241699e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.335475468652e+01 lambda=3.2814238215953598e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.652843583618e+01 lambda=3.2814238215953598e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.529985391051e+01 lambda=3.2814238215953602e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.366726270581e+01 lambda=3.2814238215953603e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.358115196460e+01 lambda=3.2814238215953603e-06 > > Line search: Cubically determined step, current gnorm 6.358025861312e+01 lambda=3.2814238215953605e-07 > > 23 SNES Function norm 6.358025861312e+01 > > 23 SNES VI Function norm 1849.78 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 8.812900895448e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.822426303212e+01 lambda=4.8421685266110105e-02 > > Line search: Cubically determined step, current gnorm 6.335842666537e+01 lambda=8.4588034499471741e-03 > > 24 SNES Function norm 6.335842666537e+01 > > 24 SNES VI Function norm 1993.6 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.094159193064e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.742173830047e+01 lambda=4.3243453252109078e-02 > > Line search: Cubically determined step, current gnorm 6.316236273224e+01 lambda=7.7494584282214512e-03 > > 25 SNES Function norm 6.316236273224e+01 > > 25 SNES VI Function norm 2126.62 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.160540289460e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.722886652974e+01 lambda=4.1792497999647044e-02 > > Line search: Cubically determined step, current gnorm 6.300020419956e+01 lambda=7.3335939016311632e-03 > > 26 SNES Function norm 6.300020419956e+01 > > 26 SNES VI Function norm 2252.12 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 10 > > Line search: gnorm after quadratic fit 8.890109786397e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.686097246249e+01 lambda=4.7041389395739201e-02 > > Line search: Cubically determined step, current gnorm 6.283084254493e+01 lambda=9.0792221408297433e-03 > > 27 SNES Function norm 6.283084254493e+01 > > 27 SNES VI Function norm 2404.84 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.998798828268e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.576469464321e+01 lambda=4.2887406731046039e-02 > > Line search: Cubically determined step, current gnorm 6.266968273817e+01 lambda=9.2948647727201898e-03 > > 28 SNES Function norm 6.266968273817e+01 > > 28 SNES VI Function norm 2558.11 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.199146621649e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.564298288247e+01 lambda=4.0193768728643060e-02 > > Line search: Cubically determined step, current gnorm 6.252861090423e+01 lambda=8.3932894622200105e-03 > > 29 SNES Function norm 6.252861090423e+01 > > 29 SNES VI Function norm 2698.56 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.382191898563e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.772162800128e+01 lambda=3.5914901407691102e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.485302824556e+01 lambda=4.7901702628153379e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.285215446174e+01 lambda=4.7901702628153379e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.253029194340e+01 lambda=4.7901702628153380e-05 > > Line search: Cubically determined step, current gnorm 6.252812967035e+01 lambda=1.5127710264417741e-05 > > 30 SNES Function norm 6.252812967035e+01 > > 30 SNES VI Function norm 2698.83 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.118652411357e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.495202040381e+01 lambda=4.0596953253201326e-02 > > Line search: Cubically determined step, current gnorm 6.239041273754e+01 lambda=9.5128837682561859e-03 > > 31 SNES Function norm 6.239041273754e+01 > > 31 SNES VI Function norm 2854.38 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.077825361440e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.467284344645e+01 lambda=4.0583557291813177e-02 > > Line search: Cubically determined step, current gnorm 6.225884047363e+01 lambda=9.7846838097028124e-03 > > 32 SNES Function norm 6.225884047363e+01 > > 32 SNES VI Function norm 3012.55 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.920999190500e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.466103609666e+01 lambda=4.2498592612658738e-02 > > Line search: Cubically determined step, current gnorm 6.213582712328e+01 lambda=1.0171220001350099e-02 > > 33 SNES Function norm 6.213582712328e+01 > > 33 SNES VI Function norm 3175.23 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.011924620812e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.495110751676e+01 lambda=4.2453491229013124e-02 > > Line search: Cubically determined step, current gnorm 6.201636649414e+01 lambda=9.3685443832871688e-03 > > 34 SNES Function norm 6.201636649414e+01 > > 34 SNES VI Function norm 3322.22 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.006024690051e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.414041989575e+01 lambda=4.0940226638739433e-02 > > Line search: Cubically determined step, current gnorm 6.190218472271e+01 lambda=1.0273994032172384e-02 > > 35 SNES Function norm 6.190218472271e+01 > > 35 SNES VI Function norm 3484.25 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.898991234613e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.426189506521e+01 lambda=4.3426020819675164e-02 > > Line search: Cubically determined step, current gnorm 6.178678684779e+01 lambda=1.0559984512509757e-02 > > 36 SNES Function norm 6.178678684779e+01 > > 36 SNES VI Function norm 3648.36 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.648025040907e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.404650680722e+01 lambda=4.6749921483990771e-02 > > Line search: Cubically determined step, current gnorm 6.165099494681e+01 lambda=1.1866483746353381e-02 > > 37 SNES Function norm 6.165099494681e+01 > > 37 SNES VI Function norm 3822.88 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.858076523292e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.520416756669e+01 lambda=4.2063577748779259e-02 > > Line search: Cubically determined step, current gnorm 6.152598711257e+01 lambda=7.9475995139781722e-03 > > 38 SNES Function norm 6.152598711257e+01 > > 38 SNES VI Function norm 3944.22 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.742192022113e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.343055909293e+01 lambda=3.8810591937350140e-02 > > Line search: Cubically determined step, current gnorm 6.135131913134e+01 lambda=9.8750504088198892e-03 > > 39 SNES Function norm 6.135131913134e+01 > > 39 SNES VI Function norm 4066.15 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.286112632409e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.061265007302e+01 lambda=2.9694426041134040e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.436749315348e+01 lambda=2.9694426041134044e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.299789903123e+01 lambda=2.9694426041134044e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141298285103e+01 lambda=2.9694426041134044e-05 > > Line search: Cubically determined step, current gnorm 6.135130530880e+01 lambda=2.9694426041134044e-06 > > 40 SNES Function norm 6.135130530880e+01 > > 40 SNES VI Function norm 4066.23 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.660062754407e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.674944119178e+01 lambda=4.3170190544802138e-02 > > Line search: Cubically determined step, current gnorm 6.120973541057e+01 lambda=6.1770273873522300e-03 > > 41 SNES Function norm 6.120973541057e+01 > > 41 SNES VI Function norm 4152.83 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.564645091492e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676153862982e+01 lambda=4.4220462778047379e-02 > > Line search: Cubically determined step, current gnorm 6.104393345352e+01 lambda=6.3589031499342100e-03 > > 42 SNES Function norm 6.104393345352e+01 > > 42 SNES VI Function norm 4233.82 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.368658054045e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.715427252993e+01 lambda=4.7003756543045970e-02 > > Line search: Cubically determined step, current gnorm 6.101753259623e+01 lambda=6.3787492486959132e-03 > > 43 SNES Function norm 6.101753259623e+01 > > 43 SNES VI Function norm 4314.49 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 8.442307716417e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.496496980051e+01 lambda=4.5726539795380154e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.142635208964e+01 lambda=8.4157732414286580e-03 > > Line search: Cubically determined step, current gnorm 6.095430498328e+01 lambda=2.1294466610363495e-03 > > 44 SNES Function norm 6.095430498328e+01 > > 44 SNES VI Function norm 4341.47 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 12 > > Line search: gnorm after quadratic fit 8.439891204437e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.240254752159e+01 lambda=4.3289599290802970e-02 > > Line search: Cubically determined step, current gnorm 6.081365387079e+01 lambda=1.2916446928212236e-02 > > 45 SNES Function norm 6.081365387079e+01 > > 45 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 9.664056729635e+01 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.944851102419e+01 lambda=1.8635858087631831e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.394837998027e+01 lambda=1.8635858087631832e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.278442438314e+01 lambda=1.8635858087631834e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.093400706607e+01 lambda=1.8635858087631834e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081489139942e+01 lambda=1.8635858087631835e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365630503e+01 lambda=1.8635858087631836e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365482998e+01 lambda=7.3438624052552081e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365418254e+01 lambda=2.3870801624167493e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365397577e+01 lambda=8.0330117961387493e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365390593e+01 lambda=2.6874115312641255e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388261e+01 lambda=8.9982494953058537e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387467e+01 lambda=3.0083351315759278e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387219e+01 lambda=1.0110298276678126e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387129e+01 lambda=3.3292703628714462e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387093e+01 lambda=1.0739379834615402e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=3.6237724732408161e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=1.2456833192766385e-12 > > Line search: Cubically determined step, current gnorm 6.081365387079e+01 lambda=3.5247146389212346e-13 > > 46 SNES Function norm 6.081365387079e+01 > > 46 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 1.433547268242e+03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.106740636849e+01 lambda=2.4859604812085913e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.525497375887e+01 lambda=7.2498301889276232e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367730849091e+01 lambda=7.2498301889276236e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.174333248068e+01 lambda=7.2498301889276242e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.083400168850e+01 lambda=7.2498301889276242e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081378891362e+01 lambda=7.2498301889276242e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365527548e+01 lambda=1.0753239548189211e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365445012e+01 lambda=4.4350670800939511e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365407923e+01 lambda=1.5953160232199837e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365394762e+01 lambda=5.8822684037182187e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365389903e+01 lambda=2.1599843490971948e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388111e+01 lambda=7.9357831777119289e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387457e+01 lambda=2.9181178721013368e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387223e+01 lambda=1.0733281860745436e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387132e+01 lambda=3.9236995040615546e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387106e+01 lambda=1.4351792294805992e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387081e+01 lambda=4.8683006404131606e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387087e+01 lambda=2.0863028416245319e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387080e+01 lambda=5.3058618006527772e-13 > > Line search: unable to find good step length! After 19 tries > > Line search: fnorm=6.0813653870787959e+01, gnorm=6.0813653870799314e+01, ynorm=7.0504021074247237e+02, minlambda=9.9999999999999998e-13, lambda=5.3058618006527772e-13, initial slope=-4.7232673282579080e+03 > > 47 SNES Function norm 6.081365387079e+01 > > 47 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 1.280890413731e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.053050135324e+01 lambda=2.2733898438250671e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.399979736493e+01 lambda=2.2733898438250673e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.297299206174e+01 lambda=2.2733898438250674e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.098427084652e+01 lambda=2.2733898438250677e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081555475063e+01 lambda=2.2733898438250679e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365745105e+01 lambda=2.2733898438250681e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365507363e+01 lambda=9.2077672155667702e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365429323e+01 lambda=3.2329991301020441e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365402243e+01 lambda=1.1595563414967544e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365392495e+01 lambda=4.1432803927719340e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365389024e+01 lambda=1.4815603373453140e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387781e+01 lambda=5.2922825349649990e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387324e+01 lambda=1.8866396505817014e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387173e+01 lambda=6.7568116386381729e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387107e+01 lambda=2.3800109593117919e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387094e+01 lambda=8.6880387507986266e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=2.8858967256610185e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=1.0348935437400166e-12 > > Line search: Cubically determined step, current gnorm 6.081365387077e+01 lambda=2.7070538024707468e-13 > > 48 SNES Function norm 6.081365387077e+01 > > 48 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > > Linear solve converged due to CONVERGED_RTOL iterations 11 > > Line search: gnorm after quadratic fit 1.170943716019e+02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 7.038597782185e+01 lambda=2.2207476459146142e-02 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.399318571001e+01 lambda=2.2207476459146142e-03 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.295164029113e+01 lambda=2.2207476459146143e-04 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.097743654776e+01 lambda=2.2207476459146143e-05 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081546079136e+01 lambda=2.2207476459146144e-06 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365719872e+01 lambda=2.2207476459146145e-07 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365503919e+01 lambda=9.0117449908413481e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365427749e+01 lambda=3.1364523245356123e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365401596e+01 lambda=1.1183735694685806e-08 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365392232e+01 lambda=3.9706025565052754e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388909e+01 lambda=1.4107330444508480e-09 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387724e+01 lambda=5.0110371464381371e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387308e+01 lambda=1.7820909495605996e-10 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387164e+01 lambda=6.3314737242538209e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387114e+01 lambda=2.2207910898013729e-11 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387085e+01 lambda=7.4515329000007742e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=2.7872933392432575e-12 > > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=8.8269934321345058e-13 > > Line search: unable to find good step length! After 18 tries > > Line search: fnorm=6.0813653870766274e+01, gnorm=6.0813653870831025e+01, ynorm=7.0578565675503091e+02, minlambda=9.9999999999999998e-13, lambda=8.8269934321345058e-13, initial slope=-3.8123379550451641e+03 > > Nonlinear solve did not converge due to DIVERGED_LINE_SEARCH iterations 48 > > > > Amir > > On Aug 18 2018, at 11:42 pm, Smith, Barry F. wrote: > > > > -snes_monitor -snes_linesearch_monitor -pc_type lu > > produces what? > > Barry > > The line search failing means that the direction computed is not a descent direction which could be due to a bad Jacobian or inconsistent constraints. > > > > On Aug 17, 2018, at 11:56 PM, Amir wrote: > > Hi > > I need to apply constraint to primitive variables. I am troubling to set up SNESVI. After running the code, I feel SNES is not actually solving. After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in function norm. > > I think the way I set VI maybe wrong. Sorry for my simple explanation. > > Very thankful for your time. > > Amir > > SNESCreate(PETSC_COMM_WORLD,&snes); > > SNESSetApplicationContext(snes,&user); > > SNESSetDM(snes,user.dm); > > SNESSetFunction(snes,NULL,FormFunction,&user); > > FormInitialSolution(user.X,&user); > > SNESSetSolution(snes,user.X); > > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > > SNESSetType(snes,SNESVINEWTONSSLS); > > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > > SNESGetLineSearch(snes,&linesearch); > > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > > SNESSetFromOptions(snes); > > SNESSolve(snes,NULL,user.X); > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sun Aug 19 22:14:56 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Mon, 20 Aug 2018 03:14:56 +0000 Subject: [petsc-users] Setting SNESVI In-Reply-To: <1534734601.local-6a947c4f-71fe-v1.4.2-f587b7b7@getmailspring.com> References: <4CB90C24-E326-43CE-B562-5371BB2092E3@mcs.anl.gov> <1534734601.local-6a947c4f-71fe-v1.4.2-f587b7b7@getmailspring.com> Message-ID: Can you share the code with petsc-maint at mcs.anl.gov This is very odd and unexpected and may indicate an error in PETSc. Barry > On Aug 19, 2018, at 10:12 PM, Amir wrote: > > I just put the constraint at the PETSC_INFINITY, this is what I get, which is the same as when I use NEWTONLS: > > 0 SNES Function norm 6.839972031896e+01 > 0 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 6.231294332518e+01 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 1 SNES Function norm 6.231294332518e+01 > 1 SNES VI Function norm 62.3129 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 5.677271460653e+01 > Line search: Quadratically determined step, lambda=1.0000000000000001e-01 > 2 SNES Function norm 5.677271460653e+01 > 2 SNES VI Function norm 56.7727 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 4.945867427788e+01 > Line search: Quadratically determined step, lambda=1.5314449290174556e-01 > 3 SNES Function norm 4.945867427788e+01 > 3 SNES VI Function norm 49.4587 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 3.912546059379e+01 > Line search: Quadratically determined step, lambda=2.8355714983096392e-01 > 4 SNES Function norm 3.912546059379e+01 > 4 SNES VI Function norm 39.1255 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: Using full step: fnorm 3.912546059379e+01 gnorm 3.171372000187e+01 > 5 SNES Function norm 3.171372000187e+01 > 5 SNES VI Function norm 31.7137 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: Using full step: fnorm 3.171372000187e+01 gnorm 1.036076366647e-01 > 6 SNES Function norm 1.036076366647e-01 > 6 SNES VI Function norm 0.103608 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: Using full step: fnorm 1.036076366647e-01 gnorm 1.913739253850e-06 > 7 SNES Function norm 1.913739253850e-06 > 7 SNES VI Function norm 1.91374e-06 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Nonlinear solve converged due to CONVERGED_FNORM_RELATIVE iterations 7 > > > On Aug 20 2018, at 2:00 am, Smith, Barry F. wrote: > > > Note that no constraints are reached at the first iterations despite the terrible convergence. I suspect something is wrong with either the formulation or the Jacobian (that is nothing to do with the constraints). What do you get with the same options if you do not set any constraints? The same terrible convergence or something different (send it). In PETSc 3.9 you can run with the option -snes_test_jacobian to see if the Jacobians are accurate or out of whack. > > Barry > > > On Aug 19, 2018, at 9:19 AM, Amir wrote: > > This is what I get after I modify the constraints, and using lu: > 0 SNES Function norm 6.839975279451e+01 > 0 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 1 > Line search: gnorm after quadratic fit 1.167382139621e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.661035212791e+01 lambda=1.4620823686291085e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.872462383177e+01 lambda=1.4620823686291085e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.010735352812e+01 lambda=1.4620823686291087e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.845164828370e+01 lambda=1.4620823686291088e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840024692820e+01 lambda=1.4620823686291089e-06 > Line search: Cubically determined step, current gnorm 6.839974867692e+01 lambda=1.4620823686291089e-07 > 1 SNES Function norm 6.839974867692e+01 > 1 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 1 > Line search: gnorm after quadratic fit 1.313376791907e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.102614855398e+02 lambda=1.4115774027030809e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 9.096517666290e+01 lambda=1.4115774027030810e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.587134084601e+01 lambda=1.4115774027030810e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.877273920434e+01 lambda=1.4115774027030810e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840408582565e+01 lambda=1.4115774027030811e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.839977811504e+01 lambda=1.4115774027030813e-07 > Line search: Cubically determined step, current gnorm 6.839974761445e+01 lambda=1.7645101306134412e-08 > 2 SNES Function norm 6.839974761445e+01 > 2 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 1.053816835919e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.064875244204e+02 lambda=2.9620424834498244e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.928160190384e+01 lambda=2.9620424834498247e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.462621000022e+01 lambda=2.9620424834498249e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.862607236334e+01 lambda=2.9620424834498250e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840219410268e+01 lambda=2.9620424834498251e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.839975697009e+01 lambda=2.9620424834498251e-07 > Line search: Cubically determined step, current gnorm 6.839974486019e+01 lambda=1.0073837635308560e-07 > 3 SNES Function norm 6.839974486019e+01 > 3 SNES VI Function norm 68.3997 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 1.235990792724e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 1.013971718389e+02 lambda=2.3488863243422971e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.781731557824e+01 lambda=2.3488863243422975e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.872972483427e+01 lambda=2.3488863243422976e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.840207967049e+01 lambda=2.3488863243422978e-05 > Line search: Cubically determined step, current gnorm 6.839957781288e+01 lambda=4.7431867318372446e-06 > 4 SNES Function norm 6.839957781288e+01 > 4 SNES VI Function norm 68.4009 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 1.076412782767e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.067259042361e+01 lambda=2.9654955573060381e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.991099677071e+01 lambda=2.9654955573060384e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.841319422751e+01 lambda=2.9654955573060385e-04 > Line search: Cubically determined step, current gnorm 6.839661391957e+01 lambda=8.6072251116571315e-05 > 5 SNES Function norm 6.839661391957e+01 > 5 SNES VI Function norm 68.4308 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 2 > Line search: gnorm after quadratic fit 9.167521781305e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.101349837507e+01 lambda=6.4300240519536755e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.041475585659e+01 lambda=6.6547102741568651e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.844705599568e+01 lambda=6.6547102741568653e-04 > Line search: Cubically determined step, current gnorm 6.839121015135e+01 lambda=1.4965127147397144e-04 > 6 SNES Function norm 6.839121015135e+01 > 6 SNES VI Function norm 68.5745 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 3 > Line search: gnorm after quadratic fit 9.587731188484e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 8.197287845440e+01 lambda=5.2775823101139679e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.940305546680e+01 lambda=5.2775823101139686e-03 > Line search: Cubically determined step, current gnorm 6.837177518619e+01 lambda=6.3969948101878912e-04 > 7 SNES Function norm 6.837177518619e+01 > 7 SNES VI Function norm 71.0652 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 3 > Line search: gnorm after quadratic fit 9.548865181502e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.876974019161e+01 lambda=5.0026957605696178e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.891985531663e+01 lambda=5.1260581886742491e-03 > Line search: Cubically determined step, current gnorm 6.832012833110e+01 lambda=9.3300874565775075e-04 > 8 SNES Function norm 6.832012833110e+01 > 8 SNES VI Function norm 79.8569 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 4 > Line search: gnorm after quadratic fit 9.541909192352e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.493349067288e+01 lambda=5.1388541796399699e-02 > Line search: Cubically determined step, current gnorm 6.781311229195e+01 lambda=7.6704381452756282e-03 > 9 SNES Function norm 6.781311229195e+01 > 9 SNES VI Function norm 206.467 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 6 > Line search: gnorm after quadratic fit 9.394254710662e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.306526091645e+01 lambda=5.3539445292607950e-02 > Line search: Cubically determined step, current gnorm 6.721835250392e+01 lambda=9.5561464381222188e-03 > 10 SNES Function norm 6.721835250392e+01 > 10 SNES VI Function norm 368.277 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 7 > Line search: gnorm after quadratic fit 9.387716261564e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.070868333837e+01 lambda=4.9443994240769853e-02 > Line search: Cubically determined step, current gnorm 6.660967991379e+01 lambda=1.0810468882260445e-02 > 11 SNES Function norm 6.660967991379e+01 > 11 SNES VI Function norm 567.089 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 9 > Line search: gnorm after quadratic fit 9.346306901087e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.048649174104e+01 lambda=4.9192073733008407e-02 > Line search: Cubically determined step, current gnorm 6.608645472517e+01 lambda=1.0044112192046832e-02 > 12 SNES Function norm 6.608645472517e+01 > 12 SNES VI Function norm 734.752 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 8 > Line search: gnorm after quadratic fit 9.452595067062e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.208837086000e+01 lambda=4.5128845776024190e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.800731174084e+01 lambda=6.5132735322282484e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.634685717588e+01 lambda=6.5132735322282484e-04 > Line search: Cubically determined step, current gnorm 6.608637269301e+01 lambda=6.5132735322282487e-05 > 13 SNES Function norm 6.608637269301e+01 > 13 SNES VI Function norm 735.814 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 8 > Line search: gnorm after quadratic fit 9.318693996551e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.139943393009e+01 lambda=4.8118075850982413e-02 > Line search: Cubically determined step, current gnorm 6.568600823304e+01 lambda=7.8756632431255542e-03 > 14 SNES Function norm 6.568600823304e+01 > 14 SNES VI Function norm 881.479 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 9 > Line search: gnorm after quadratic fit 9.242424276014e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.226307852468e+01 lambda=4.8021995541678457e-02 > Line search: Cubically determined step, current gnorm 6.540144178550e+01 lambda=6.6931701304969058e-03 > 15 SNES Function norm 6.540144178550e+01 > 15 SNES VI Function norm 1006.28 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.154992244384e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.122067564574e+01 lambda=5.0277415210907568e-02 > Line search: Cubically determined step, current gnorm 6.506969399500e+01 lambda=7.8660529387648906e-03 > 16 SNES Function norm 6.506969399500e+01 > 16 SNES VI Function norm 1131.4 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.263744099217e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.045825559590e+01 lambda=4.3976587783298791e-02 > Line search: Cubically determined step, current gnorm 6.477740872258e+01 lambda=6.6653314620139965e-03 > 17 SNES Function norm 6.477740872258e+01 > 17 SNES VI Function norm 1252.29 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.034042193429e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.097176730586e+01 lambda=4.9082849797732621e-02 > Line search: Cubically determined step, current gnorm 6.448770943479e+01 lambda=7.1730414269226593e-03 > 18 SNES Function norm 6.448770943479e+01 > 18 SNES VI Function norm 1371.72 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.028256513212e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.990381886066e+01 lambda=4.4193294185915478e-02 > Line search: Cubically determined step, current gnorm 6.422123220407e+01 lambda=6.6250183714544201e-03 > 19 SNES Function norm 6.422123220407e+01 > 19 SNES VI Function norm 1490.87 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.908334154738e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.060161630260e+01 lambda=4.6452357120490895e-02 > Line search: Cubically determined step, current gnorm 6.411445689017e+01 lambda=6.3417192629449783e-03 > 20 SNES Function norm 6.411445689017e+01 > 20 SNES VI Function norm 1597.29 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.460267552084e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.051195181220e+01 lambda=5.8933530173091400e-02 > Line search: Cubically determined step, current gnorm 6.379276529842e+01 lambda=9.2451193719573169e-03 > 21 SNES Function norm 6.379276529842e+01 > 21 SNES VI Function norm 1729.35 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.847710713735e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.007434740347e+01 lambda=4.8620669909360585e-02 > Line search: Cubically determined step, current gnorm 6.358026444281e+01 lambda=6.8922394760267177e-03 > 22 SNES Function norm 6.358026444281e+01 > 22 SNES VI Function norm 1849.77 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 9.435581241699e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.335475468652e+01 lambda=3.2814238215953598e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.652843583618e+01 lambda=3.2814238215953598e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.529985391051e+01 lambda=3.2814238215953602e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.366726270581e+01 lambda=3.2814238215953603e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.358115196460e+01 lambda=3.2814238215953603e-06 > Line search: Cubically determined step, current gnorm 6.358025861312e+01 lambda=3.2814238215953605e-07 > 23 SNES Function norm 6.358025861312e+01 > 23 SNES VI Function norm 1849.78 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.812900895448e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.822426303212e+01 lambda=4.8421685266110105e-02 > Line search: Cubically determined step, current gnorm 6.335842666537e+01 lambda=8.4588034499471741e-03 > 24 SNES Function norm 6.335842666537e+01 > 24 SNES VI Function norm 1993.6 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.094159193064e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.742173830047e+01 lambda=4.3243453252109078e-02 > Line search: Cubically determined step, current gnorm 6.316236273224e+01 lambda=7.7494584282214512e-03 > 25 SNES Function norm 6.316236273224e+01 > 25 SNES VI Function norm 2126.62 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.160540289460e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.722886652974e+01 lambda=4.1792497999647044e-02 > Line search: Cubically determined step, current gnorm 6.300020419956e+01 lambda=7.3335939016311632e-03 > 26 SNES Function norm 6.300020419956e+01 > 26 SNES VI Function norm 2252.12 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 10 > Line search: gnorm after quadratic fit 8.890109786397e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.686097246249e+01 lambda=4.7041389395739201e-02 > Line search: Cubically determined step, current gnorm 6.283084254493e+01 lambda=9.0792221408297433e-03 > 27 SNES Function norm 6.283084254493e+01 > 27 SNES VI Function norm 2404.84 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.998798828268e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.576469464321e+01 lambda=4.2887406731046039e-02 > Line search: Cubically determined step, current gnorm 6.266968273817e+01 lambda=9.2948647727201898e-03 > 28 SNES Function norm 6.266968273817e+01 > 28 SNES VI Function norm 2558.11 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.199146621649e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.564298288247e+01 lambda=4.0193768728643060e-02 > Line search: Cubically determined step, current gnorm 6.252861090423e+01 lambda=8.3932894622200105e-03 > 29 SNES Function norm 6.252861090423e+01 > 29 SNES VI Function norm 2698.56 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.382191898563e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.772162800128e+01 lambda=3.5914901407691102e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.485302824556e+01 lambda=4.7901702628153379e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.285215446174e+01 lambda=4.7901702628153379e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.253029194340e+01 lambda=4.7901702628153380e-05 > Line search: Cubically determined step, current gnorm 6.252812967035e+01 lambda=1.5127710264417741e-05 > 30 SNES Function norm 6.252812967035e+01 > 30 SNES VI Function norm 2698.83 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.118652411357e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.495202040381e+01 lambda=4.0596953253201326e-02 > Line search: Cubically determined step, current gnorm 6.239041273754e+01 lambda=9.5128837682561859e-03 > 31 SNES Function norm 6.239041273754e+01 > 31 SNES VI Function norm 2854.38 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.077825361440e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.467284344645e+01 lambda=4.0583557291813177e-02 > Line search: Cubically determined step, current gnorm 6.225884047363e+01 lambda=9.7846838097028124e-03 > 32 SNES Function norm 6.225884047363e+01 > 32 SNES VI Function norm 3012.55 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.920999190500e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.466103609666e+01 lambda=4.2498592612658738e-02 > Line search: Cubically determined step, current gnorm 6.213582712328e+01 lambda=1.0171220001350099e-02 > 33 SNES Function norm 6.213582712328e+01 > 33 SNES VI Function norm 3175.23 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.011924620812e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.495110751676e+01 lambda=4.2453491229013124e-02 > Line search: Cubically determined step, current gnorm 6.201636649414e+01 lambda=9.3685443832871688e-03 > 34 SNES Function norm 6.201636649414e+01 > 34 SNES VI Function norm 3322.22 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.006024690051e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.414041989575e+01 lambda=4.0940226638739433e-02 > Line search: Cubically determined step, current gnorm 6.190218472271e+01 lambda=1.0273994032172384e-02 > 35 SNES Function norm 6.190218472271e+01 > 35 SNES VI Function norm 3484.25 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.898991234613e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.426189506521e+01 lambda=4.3426020819675164e-02 > Line search: Cubically determined step, current gnorm 6.178678684779e+01 lambda=1.0559984512509757e-02 > 36 SNES Function norm 6.178678684779e+01 > 36 SNES VI Function norm 3648.36 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.648025040907e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.404650680722e+01 lambda=4.6749921483990771e-02 > Line search: Cubically determined step, current gnorm 6.165099494681e+01 lambda=1.1866483746353381e-02 > 37 SNES Function norm 6.165099494681e+01 > 37 SNES VI Function norm 3822.88 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.858076523292e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.520416756669e+01 lambda=4.2063577748779259e-02 > Line search: Cubically determined step, current gnorm 6.152598711257e+01 lambda=7.9475995139781722e-03 > 38 SNES Function norm 6.152598711257e+01 > 38 SNES VI Function norm 3944.22 Active lower constraints 0/0 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.742192022113e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.343055909293e+01 lambda=3.8810591937350140e-02 > Line search: Cubically determined step, current gnorm 6.135131913134e+01 lambda=9.8750504088198892e-03 > 39 SNES Function norm 6.135131913134e+01 > 39 SNES VI Function norm 4066.15 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.286112632409e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.061265007302e+01 lambda=2.9694426041134040e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.436749315348e+01 lambda=2.9694426041134044e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.299789903123e+01 lambda=2.9694426041134044e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.141298285103e+01 lambda=2.9694426041134044e-05 > Line search: Cubically determined step, current gnorm 6.135130530880e+01 lambda=2.9694426041134044e-06 > 40 SNES Function norm 6.135130530880e+01 > 40 SNES VI Function norm 4066.23 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.660062754407e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.674944119178e+01 lambda=4.3170190544802138e-02 > Line search: Cubically determined step, current gnorm 6.120973541057e+01 lambda=6.1770273873522300e-03 > 41 SNES Function norm 6.120973541057e+01 > 41 SNES VI Function norm 4152.83 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.564645091492e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.676153862982e+01 lambda=4.4220462778047379e-02 > Line search: Cubically determined step, current gnorm 6.104393345352e+01 lambda=6.3589031499342100e-03 > 42 SNES Function norm 6.104393345352e+01 > 42 SNES VI Function norm 4233.82 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.368658054045e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.715427252993e+01 lambda=4.7003756543045970e-02 > Line search: Cubically determined step, current gnorm 6.101753259623e+01 lambda=6.3787492486959132e-03 > 43 SNES Function norm 6.101753259623e+01 > 43 SNES VI Function norm 4314.49 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 8.442307716417e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.496496980051e+01 lambda=4.5726539795380154e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.142635208964e+01 lambda=8.4157732414286580e-03 > Line search: Cubically determined step, current gnorm 6.095430498328e+01 lambda=2.1294466610363495e-03 > 44 SNES Function norm 6.095430498328e+01 > 44 SNES VI Function norm 4341.47 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 12 > Line search: gnorm after quadratic fit 8.439891204437e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.240254752159e+01 lambda=4.3289599290802970e-02 > Line search: Cubically determined step, current gnorm 6.081365387079e+01 lambda=1.2916446928212236e-02 > 45 SNES Function norm 6.081365387079e+01 > 45 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 9.664056729635e+01 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.944851102419e+01 lambda=1.8635858087631831e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.394837998027e+01 lambda=1.8635858087631832e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.278442438314e+01 lambda=1.8635858087631834e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.093400706607e+01 lambda=1.8635858087631834e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081489139942e+01 lambda=1.8635858087631835e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365630503e+01 lambda=1.8635858087631836e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365482998e+01 lambda=7.3438624052552081e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365418254e+01 lambda=2.3870801624167493e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365397577e+01 lambda=8.0330117961387493e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365390593e+01 lambda=2.6874115312641255e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388261e+01 lambda=8.9982494953058537e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387467e+01 lambda=3.0083351315759278e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387219e+01 lambda=1.0110298276678126e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387129e+01 lambda=3.3292703628714462e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387093e+01 lambda=1.0739379834615402e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=3.6237724732408161e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=1.2456833192766385e-12 > Line search: Cubically determined step, current gnorm 6.081365387079e+01 lambda=3.5247146389212346e-13 > 46 SNES Function norm 6.081365387079e+01 > 46 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 1.433547268242e+03 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.106740636849e+01 lambda=2.4859604812085913e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.525497375887e+01 lambda=7.2498301889276232e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.367730849091e+01 lambda=7.2498301889276236e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.174333248068e+01 lambda=7.2498301889276242e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.083400168850e+01 lambda=7.2498301889276242e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081378891362e+01 lambda=7.2498301889276242e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365527548e+01 lambda=1.0753239548189211e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365445012e+01 lambda=4.4350670800939511e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365407923e+01 lambda=1.5953160232199837e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365394762e+01 lambda=5.8822684037182187e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365389903e+01 lambda=2.1599843490971948e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388111e+01 lambda=7.9357831777119289e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387457e+01 lambda=2.9181178721013368e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387223e+01 lambda=1.0733281860745436e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387132e+01 lambda=3.9236995040615546e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387106e+01 lambda=1.4351792294805992e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387081e+01 lambda=4.8683006404131606e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387087e+01 lambda=2.0863028416245319e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387080e+01 lambda=5.3058618006527772e-13 > Line search: unable to find good step length! After 19 tries > Line search: fnorm=6.0813653870787959e+01, gnorm=6.0813653870799314e+01, ynorm=7.0504021074247237e+02, minlambda=9.9999999999999998e-13, lambda=5.3058618006527772e-13, initial slope=-4.7232673282579080e+03 > 47 SNES Function norm 6.081365387079e+01 > 47 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 1.280890413731e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.053050135324e+01 lambda=2.2733898438250671e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.399979736493e+01 lambda=2.2733898438250673e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.297299206174e+01 lambda=2.2733898438250674e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.098427084652e+01 lambda=2.2733898438250677e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081555475063e+01 lambda=2.2733898438250679e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365745105e+01 lambda=2.2733898438250681e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365507363e+01 lambda=9.2077672155667702e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365429323e+01 lambda=3.2329991301020441e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365402243e+01 lambda=1.1595563414967544e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365392495e+01 lambda=4.1432803927719340e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365389024e+01 lambda=1.4815603373453140e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387781e+01 lambda=5.2922825349649990e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387324e+01 lambda=1.8866396505817014e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387173e+01 lambda=6.7568116386381729e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387107e+01 lambda=2.3800109593117919e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387094e+01 lambda=8.6880387507986266e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=2.8858967256610185e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=1.0348935437400166e-12 > Line search: Cubically determined step, current gnorm 6.081365387077e+01 lambda=2.7070538024707468e-13 > 48 SNES Function norm 6.081365387077e+01 > 48 SNES VI Function norm 4500.53 Active lower constraints 0/1 upper constraints 0/0 Percent of total 0. Percent of bounded 0. > Linear solve converged due to CONVERGED_RTOL iterations 11 > Line search: gnorm after quadratic fit 1.170943716019e+02 > Line search: Cubic step no good, shrinking lambda, current gnorm 7.038597782185e+01 lambda=2.2207476459146142e-02 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.399318571001e+01 lambda=2.2207476459146142e-03 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.295164029113e+01 lambda=2.2207476459146143e-04 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.097743654776e+01 lambda=2.2207476459146143e-05 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081546079136e+01 lambda=2.2207476459146144e-06 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365719872e+01 lambda=2.2207476459146145e-07 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365503919e+01 lambda=9.0117449908413481e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365427749e+01 lambda=3.1364523245356123e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365401596e+01 lambda=1.1183735694685806e-08 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365392232e+01 lambda=3.9706025565052754e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365388909e+01 lambda=1.4107330444508480e-09 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387724e+01 lambda=5.0110371464381371e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387308e+01 lambda=1.7820909495605996e-10 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387164e+01 lambda=6.3314737242538209e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387114e+01 lambda=2.2207910898013729e-11 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387085e+01 lambda=7.4515329000007742e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387082e+01 lambda=2.7872933392432575e-12 > Line search: Cubic step no good, shrinking lambda, current gnorm 6.081365387083e+01 lambda=8.8269934321345058e-13 > Line search: unable to find good step length! After 18 tries > Line search: fnorm=6.0813653870766274e+01, gnorm=6.0813653870831025e+01, ynorm=7.0578565675503091e+02, minlambda=9.9999999999999998e-13, lambda=8.8269934321345058e-13, initial slope=-3.8123379550451641e+03 > Nonlinear solve did not converge due to DIVERGED_LINE_SEARCH iterations 48 > > Amir > > On Aug 18 2018, at 11:42 pm, Smith, Barry F. wrote: > > > -snes_monitor -snes_linesearch_monitor -pc_type lu > > produces what? > > Barry > > The line search failing means that the direction computed is not a descent direction which could be due to a bad Jacobian or inconsistent constraints. > > > On Aug 17, 2018, at 11:56 PM, Amir wrote: > > Hi > I need to apply constraint to primitive variables. I am troubling to set up SNESVI. After running the code, I feel SNES is not actually solving. After one iteration of SNES, I got DIVERGED_LINESEARCH, with NO changing in function norm. > I think the way I set VI maybe wrong. Sorry for my simple explanation. > Very thankful for your time. > Amir > SNESCreate(PETSC_COMM_WORLD,&snes); > SNESSetApplicationContext(snes,&user); > SNESSetDM(snes,user.dm); > SNESSetFunction(snes,NULL,FormFunction,&user); > FormInitialSolution(user.X,&user); > SNESSetSolution(snes,user.X); > SNESMonitorSet(snes,MySNESMonitor,&user,NULL); > SNESSetType(snes,SNESVINEWTONSSLS); > SNESSetNormSchedule(snes, SNES_NORM_ALWAYS); > SNESVISetVariableBounds(snes,user.XLOWER,user.XUPPER); > SNESGetLineSearch(snes,&linesearch); > SNESLineSearchSetType(linesearch,SNESLINESEARCHBT); > SNESLineSearchSetVIFunctions(linesearch, NULL, SNESNormFunction); > SNESSetFromOptions(snes); > SNESSolve(snes,NULL,user.X); From bsmith at mcs.anl.gov Sun Aug 19 22:24:33 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Mon, 20 Aug 2018 03:24:33 +0000 Subject: [petsc-users] v3.9.3 config problem In-Reply-To: <4ccdfb55-4197-4c3e-967f-26e1cc6ee96c@auckland.ac.nz> References: <88062aed-0fc8-c891-3f73-65858406b916@auckland.ac.nz> <19461756-1DE5-4E3C-8EA1-7AB65F777AE7@anl.gov> <4ccdfb55-4197-4c3e-967f-26e1cc6ee96c@auckland.ac.nz> Message-ID: This is insanely bad for users (including me as a user). You shouldn't need to delete anything. You just need the additional flag of either --download-zlib or --with-zlib (if it is installed on your system). The new branch barry/fix-insanity-netcdf/maint will give you a very useful error message if you don't pass in the zlib. So people won't waste their time on this same problem in the future. Sorry to waste your time, Barry The netcdf code didn't build netcdf4 without access to zlib but it didn't bother to tell you it wasn't building it. Then when exodusii needed netcdf4 it assumed it was there (though it wasn't) and hence the bad compile. I'm also surprised this didn't happen before to other users. > On Aug 19, 2018, at 9:01 PM, Adrian Croucher wrote: > > Should I try wiping out the externalpackages directory as well as $PETSC_ARCH? > > - Adrian > > On 20/08/18 14:00, Smith, Barry F. wrote: >> Trying to reproduce it now but I'm pretty sure we've tested it. >> >> Do you have some old files lying around that might be causing the problem? >> >> /home/acro018/software/PETSc/code/linux-gnu-c-opt/externalpackages/git.exodusii/packages/seacas/libraries/exodus/src/ex_create_par.c:375:9: error: 'netcdf4_mode' undeclared (first use in this function) >> if (netcdf4_mode == -1) { >> >> Maybe externalpackages has downloads from a previous build still located that don't work with the latest exodusii? >> >> >> Barry >> >> >> >> >>> On Aug 19, 2018, at 8:51 PM, Adrian Croucher wrote: >>> >>> hi >>> >>> I just pulled the latest PETSc master branch (v3.9.3) but am having trouble building it. It's been running fine on v3.8.4. >>> >>> I deleted my $PETSC_ARCH directory and tried to configure. But it seems to be falling over when trying to build Exodus. I've attached the configure.log. >>> >>> Any ideas? >>> >>> - Adrian >>> >>> -- >>> Dr Adrian Croucher >>> Senior Research Fellow >>> Department of Engineering Science >>> University of Auckland, New Zealand >>> email: a.croucher at auckland.ac.nz >>> tel: +64 (0)9 923 4611 >>> >>> > > -- > Dr Adrian Croucher > Senior Research Fellow > Department of Engineering Science > University of Auckland, New Zealand > email: a.croucher at auckland.ac.nz > tel: +64 (0)9 923 4611 > From a.croucher at auckland.ac.nz Sun Aug 19 22:45:18 2018 From: a.croucher at auckland.ac.nz (Adrian Croucher) Date: Mon, 20 Aug 2018 15:45:18 +1200 Subject: [petsc-users] v3.9.3 config problem In-Reply-To: References: <88062aed-0fc8-c891-3f73-65858406b916@auckland.ac.nz> <19461756-1DE5-4E3C-8EA1-7AB65F777AE7@anl.gov> <4ccdfb55-4197-4c3e-967f-26e1cc6ee96c@auckland.ac.nz> Message-ID: Whew, that is looking much healthier now. Thanks very much for tracking that down... - Adrian On 20/08/18 15:24, Smith, Barry F. wrote: > This is insanely bad for users (including me as a user). > > You shouldn't need to delete anything. > > You just need the additional flag of either --download-zlib or --with-zlib (if it is installed on your system). > > The new branch barry/fix-insanity-netcdf/maint will give you a very useful error message if you don't pass in the zlib. So people won't waste their time on this same problem in the future. > > Sorry to waste your time, > > Barry > > The netcdf code didn't build netcdf4 without access to zlib but it didn't bother to tell you it wasn't building it. Then when exodusii needed netcdf4 it assumed it was there (though it wasn't) and hence the bad compile. I'm also surprised this didn't happen before to other users. > -- Dr Adrian Croucher Senior Research Fellow Department of Engineering Science University of Auckland, New Zealand email: a.croucher at auckland.ac.nz tel: +64 (0)9 923 4611 From ellen.price at cfa.harvard.edu Tue Aug 21 21:00:38 2018 From: ellen.price at cfa.harvard.edu (Ellen M. Price) Date: Tue, 21 Aug 2018 22:00:38 -0400 Subject: [petsc-users] Debugging SNES when "everything" looks okay Message-ID: Hi PETSc users, I'm having trouble applying SNES to a new problem I'm working on. I'll try to be as complete as possible but can't post the full code because it's ongoing research and is pretty long anyway. The nonlinear problem arises from trying to solve a set of two coupled ODEs using a Galerkin method. I am using Mathematica to generate the objective function to solve and the Jacobian, so I *think* I can rule out human error on that front. There are four things I can easily change: - number of DMDA grid points N (I've tried 100 and 1000) - preconditioner (I've tried LU and SVD, LU appears to work better, and SVD is too slow for N = 1000) - linear solver (haven't played with this much, but sometimes smaller tolerances work better) - nonlinear solver (what I'm having trouble with) Trying different solvers should, as far as I'm aware, give comparable answers, but that's not the case here. NEWTONTR works best of the ones I've tried, but I'm suspicious that the function value barely decreases before SNES "converges" -- and none of the options I've tried changing seem to affect this, as it just finds another reason to converge without making any real progress. For example: 0 SNES Function norm 7.197788479418e+00 0 KSP Residual norm 1.721996766619e+01 1 KSP Residual norm 5.186021549059e-14 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 1 SNES Function norm 7.197777674987e+00 0 KSP Residual norm 3.296112185897e+01 1 KSP Residual norm 2.713415432045e-13 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 ..... 50 SNES Function norm 7.197376803542e+00 0 KSP Residual norm 6.222518656302e+02 1 KSP Residual norm 9.630659996504e-12 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 51 SNES Function norm 7.197376803542e+00 Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 I've tried everything I can think of and the FAQ suggestions, including non-dimensionalizing the problem; I observe the same behavior either way. The particularly strange thing I can't understand is why some of the SNES methods fail outright, after just one iteration (NCG, NGMRES, and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems like, for the most part, I should be able to substitute in one method for another, possibly adjusting a few parameters along the way. Furthermore, the default method, NEWTONLS, diverges with DIVERGED_LINE_SEARCH, which I'm not sure how to debug. So the only viable method is NEWTONTR, and that doesn't appear to "really" converge. Any suggestions for further things to try are appreciated. My current options are: -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason -snes_max_it 10000 -ksp_monitor -snes_type newtonls Thanks in advance, Ellen Price From bsmith at mcs.anl.gov Tue Aug 21 21:13:35 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 22 Aug 2018 02:13:35 +0000 Subject: [petsc-users] Debugging SNES when "everything" looks okay In-Reply-To: References: Message-ID: <98BEB530-B407-41FC-BAEB-5F9B4365F593@anl.gov> Ellen, 1) The number one cause of failed Newton's method is incorrect Jacobians. PETSc 3.9 has an improved way of checking the Jacobian. Just run the code with the same options as given below plus -snes_test_jacobian and confirm if it believes the the Jacobian is correct. If the Jacobians look good you can run with -snes_linesearch_monitor to see how the SNES solve is failing. 2) A less common but possible cause is that the initial guess you are using is too far from the "basin of attraction" of Newton's method so that convergence just won't happen. To test this start with a very small N (say 4), does Newton's method converge? What about N of say 8? If it converges for small N you can use grid sequencing to generate initial guesses for the finer mesh from the coarser mesh. The SNES options for this is - snes_grid_sequence Good luck, Barry 3) The solvers can also fail if the function evaluation is "wrong" but that is much harder to test for. > On Aug 21, 2018, at 9:00 PM, Ellen M. Price wrote: > > Hi PETSc users, > > I'm having trouble applying SNES to a new problem I'm working on. I'll > try to be as complete as possible but can't post the full code because > it's ongoing research and is pretty long anyway. > > The nonlinear problem arises from trying to solve a set of two coupled > ODEs using a Galerkin method. I am using Mathematica to generate the > objective function to solve and the Jacobian, so I *think* I can rule > out human error on that front. > > There are four things I can easily change: > > - number of DMDA grid points N (I've tried 100 and 1000) > - preconditioner (I've tried LU and SVD, LU appears to work better, and > SVD is too slow for N = 1000) > - linear solver (haven't played with this much, but sometimes smaller > tolerances work better) > - nonlinear solver (what I'm having trouble with) > > Trying different solvers should, as far as I'm aware, give comparable > answers, but that's not the case here. NEWTONTR works best of the ones > I've tried, but I'm suspicious that the function value barely decreases > before SNES "converges" -- and none of the options I've tried changing > seem to affect this, as it just finds another reason to converge without > making any real progress. For example: > > 0 SNES Function norm 7.197788479418e+00 > 0 KSP Residual norm 1.721996766619e+01 > 1 KSP Residual norm 5.186021549059e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 1 SNES Function norm 7.197777674987e+00 > 0 KSP Residual norm 3.296112185897e+01 > 1 KSP Residual norm 2.713415432045e-13 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > ..... > 50 SNES Function norm 7.197376803542e+00 > 0 KSP Residual norm 6.222518656302e+02 > 1 KSP Residual norm 9.630659996504e-12 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 51 SNES Function norm 7.197376803542e+00 > Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 > > I've tried everything I can think of and the FAQ suggestions, including > non-dimensionalizing the problem; I observe the same behavior either > way. The particularly strange thing I can't understand is why some of > the SNES methods fail outright, after just one iteration (NCG, NGMRES, > and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems > like, for the most part, I should be able to substitute in one method > for another, possibly adjusting a few parameters along the way. > Furthermore, the default method, NEWTONLS, diverges with > DIVERGED_LINE_SEARCH, which I'm not sure how to debug. > > So the only viable method is NEWTONTR, and that doesn't appear to > "really" converge. Any suggestions for further things to try are > appreciated. My current options are: > > -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason > -snes_max_it 10000 -ksp_monitor -snes_type newtonls > > Thanks in advance, > Ellen Price From knepley at gmail.com Tue Aug 21 21:15:56 2018 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 21 Aug 2018 22:15:56 -0400 Subject: [petsc-users] Debugging SNES when "everything" looks okay In-Reply-To: References: Message-ID: On Tue, Aug 21, 2018 at 10:00 PM Ellen M. Price wrote: > Hi PETSc users, > > I'm having trouble applying SNES to a new problem I'm working on. I'll > try to be as complete as possible but can't post the full code because > it's ongoing research and is pretty long anyway. > > The nonlinear problem arises from trying to solve a set of two coupled > ODEs using a Galerkin method. I am using Mathematica to generate the > objective function to solve and the Jacobian, so I *think* I can rule > out human error on that front. > > There are four things I can easily change: > > - number of DMDA grid points N (I've tried 100 and 1000) > - preconditioner (I've tried LU and SVD, LU appears to work better, and > SVD is too slow for N = 1000) > - linear solver (haven't played with this much, but sometimes smaller > tolerances work better) > - nonlinear solver (what I'm having trouble with) > > Trying different solvers should, as far as I'm aware, give comparable > answers, but that's not the case here. NEWTONTR works best of the ones > I've tried, but I'm suspicious that the function value barely decreases > before SNES "converges" -- and none of the options I've tried changing > seem to affect this, as it just finds another reason to converge without > making any real progress. For example: > > 0 SNES Function norm 7.197788479418e+00 > 0 KSP Residual norm 1.721996766619e+01 > 1 KSP Residual norm 5.186021549059e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > This makes no sense. LU should converge due to atol or rtol. Send the output of -snes_view -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason Thanks, Matt > 1 SNES Function norm 7.197777674987e+00 > 0 KSP Residual norm 3.296112185897e+01 > 1 KSP Residual norm 2.713415432045e-13 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > ..... > 50 SNES Function norm 7.197376803542e+00 > 0 KSP Residual norm 6.222518656302e+02 > 1 KSP Residual norm 9.630659996504e-12 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 51 SNES Function norm 7.197376803542e+00 > Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 > > I've tried everything I can think of and the FAQ suggestions, including > non-dimensionalizing the problem; I observe the same behavior either > way. The particularly strange thing I can't understand is why some of > the SNES methods fail outright, after just one iteration (NCG, NGMRES, > and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems > like, for the most part, I should be able to substitute in one method > for another, possibly adjusting a few parameters along the way. > Furthermore, the default method, NEWTONLS, diverges with > DIVERGED_LINE_SEARCH, which I'm not sure how to debug. > > So the only viable method is NEWTONTR, and that doesn't appear to > "really" converge. Any suggestions for further things to try are > appreciated. My current options are: > > -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason > -snes_max_it 10000 -ksp_monitor -snes_type newtonls > > Thanks in advance, > Ellen Price > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From ellen.price at cfa.harvard.edu Wed Aug 22 12:33:18 2018 From: ellen.price at cfa.harvard.edu (Ellen Price) Date: Wed, 22 Aug 2018 13:33:18 -0400 Subject: [petsc-users] Debugging SNES when "everything" looks okay In-Reply-To: References: Message-ID: For Barry: Okay, I'm stumped. Some of my Jacobian terms match up with the finite difference one. Others are off by orders of magnitude. This led me to think that maybe there was something wrong with my analytic Jacobian, so I went back and started trying to track down which term causes the problem. The weird thing is that Mathematica gives the same numerical result as my code (within a small tolerance), whether i substitute numbers into its analytic Jacobian or numerically differentiate the function I'm trying to solve using Mathematica. I can't think of anything else to try for debugging the Jacobian. Even if the function has a bug in it, Mathematica seems pretty sure that I'm using the right Jacobian for what I put in... At the suggestion of the FAQ, I also tried "-mat_fd_type ds" to see if that made any difference, but it doesn't. Like I said, I'm stumped, but I'll keep trying. For Matt: Using options "-pc_type lu -snes_view -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason -snes_type newtontr", the output is below. I thought that the step length convergence message had something to do with using NEWTONTR, but I could be wrong about that. It doesn't give that message when I switch to NEWTONLS. It also only gives that message after the first iteration -- the first one is always CONVERGED_RTOL. 7.533921e-03, 2.054699e+02 0 SNES Function norm 6.252612941119e+04 0 KSP preconditioned resid norm 1.027204021595e-01 true resid norm 6.252612941119e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.641617517320e-17 true resid norm 3.941610607093e-11 ||r(i)||/||b|| 6.303941478885e-16 Linear solve converged due to CONVERGED_RTOL iterations 1 1 SNES Function norm 6.252085930204e+04 0 KSP preconditioned resid norm 3.857372064539e-01 true resid norm 6.252085930204e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.664921095158e-16 true resid norm 2.434875289829e-10 ||r(i)||/||b|| 3.894500678672e-15 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 2 SNES Function norm 6.251886926050e+04 0 KSP preconditioned resid norm 4.085000006938e-01 true resid norm 6.251886926050e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 5.318519617927e-16 true resid norm 8.189931340015e-10 ||r(i)||/||b|| 1.309993516660e-14 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 ..... 48 SNES Function norm 6.229932776333e+04 0 KSP preconditioned resid norm 4.872526135345e+00 true resid norm 6.229932776333e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 7.281571852581e-15 true resid norm 8.562155918387e-09 ||r(i)||/||b|| 1.374357673796e-13 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 49 SNES Function norm 6.229663411026e+04 0 KSP preconditioned resid norm 4.953303401996e+00 true resid norm 6.229663411026e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.537319689814e-15 true resid norm 4.783442569088e-09 ||r(i)||/||b|| 7.678492806886e-14 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 50 SNES Function norm 6.229442686875e+04 Nonlinear solve did not converge due to DIVERGED_MAX_IT iterations 50 SNES Object: 2 MPI processes type: newtontr Trust region tolerance (-snes_trtol) mu=0.25, eta=0.75, sigma=0.0001 delta0=0.2, delta1=0.3, delta2=0.75, delta3=2. maximum iterations=50, maximum function evaluations=10000 tolerances: relative=1e-08, absolute=1e-50, solution=1e-08 total number of linear solver iterations=50 total number of function evaluations=58 norm schedule ALWAYS SNESLineSearch Object: 2 MPI processes type: basic maxstep=1.000000e+08, minlambda=1.000000e-12 tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 maximum iterations=1 KSP Object: 2 MPI processes type: gmres restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement happy breakdown tolerance 1e-30 maximum iterations=10000, initial guess is zero tolerances: relative=1e-05, absolute=1e-50, divergence=10000. left preconditioning using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: lu out-of-place factorization tolerance for zero pivot 2.22045e-14 matrix ordering: natural factor fill ratio given 0., needed 0. Factored matrix follows: Mat Object: 2 MPI processes type: mumps rows=20, cols=20 package used to perform factorization: mumps total: nonzeros=112, allocated nonzeros=112 total number of mallocs used during MatSetValues calls =0 MUMPS run parameters: SYM (matrix type): 0 PAR (host participation): 1 ICNTL(1) (output for error): 6 ICNTL(2) (output of diagnostic msg): 0 ICNTL(3) (output for global info): 0 ICNTL(4) (level of printing): 0 ICNTL(5) (input mat struct): 0 ICNTL(6) (matrix prescaling): 7 ICNTL(7) (sequential matrix ordering):7 ICNTL(8) (scaling strategy): 77 ICNTL(10) (max num of refinements): 0 ICNTL(11) (error analysis): 0 ICNTL(12) (efficiency control): 1 ICNTL(13) (efficiency control): 0 ICNTL(14) (percentage of estimated workspace increase): 20 ICNTL(18) (input mat struct): 3 ICNTL(19) (Schur complement info): 0 ICNTL(20) (rhs sparse pattern): 0 ICNTL(21) (solution struct): 1 ICNTL(22) (in-core/out-of-core facility): 0 ICNTL(23) (max size of memory can be allocated locally):0 ICNTL(24) (detection of null pivot rows): 0 ICNTL(25) (computation of a null space basis): 0 ICNTL(26) (Schur options for rhs or solution): 0 ICNTL(27) (experimental parameter): -32 ICNTL(28) (use parallel or sequential ordering): 1 ICNTL(29) (parallel ordering): 0 ICNTL(30) (user-specified set of entries in inv(A)): 0 ICNTL(31) (factors is discarded in the solve phase): 0 ICNTL(33) (compute determinant): 0 ICNTL(35) (activate BLR based factorization): 0 CNTL(1) (relative pivoting threshold): 0.01 CNTL(2) (stopping criterion of refinement): 1.49012e-08 CNTL(3) (absolute pivoting threshold): 0. CNTL(4) (value of static pivoting): -1. CNTL(5) (fixation for null pivots): 0. CNTL(7) (dropping parameter for BLR): 0. RINFO(1) (local estimated flops for the elimination after analysis): [0] 127. [1] 155. RINFO(2) (local estimated flops for the assembly after factorization): [0] 16. [1] 16. RINFO(3) (local estimated flops for the elimination after factorization): [0] 127. [1] 155. INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 1 [1] 1 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 1 [1] 1 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 10 [1] 10 RINFOG(1) (global estimated flops for the elimination after analysis): 282. RINFOG(2) (global estimated flops for the assembly after factorization): 32. RINFOG(3) (global estimated flops for the elimination after factorization): 282. (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 112 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 225 INFOG(5) (estimated maximum front size in the complete tree): 4 INFOG(6) (number of nodes in the complete tree): 9 INFOG(7) (ordering option effectively use after analysis): 2 INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 112 INFOG(10) (total integer space store the matrix factors after factorization): 225 INFOG(11) (order of largest frontal matrix after factorization): 4 INFOG(12) (number of off-diagonal pivots): 0 INFOG(13) (number of delayed pivots after factorization): 0 INFOG(14) (number of memory compress after factorization): 0 INFOG(15) (number of steps of iterative refinement after solution): 0 INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 1 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 2 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 1 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 2 INFOG(20) (estimated number of entries in the factors): 112 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 1 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 2 INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 INFOG(28) (after factorization: number of null pivots encountered): 0 INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 112 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 0, 0 INFOG(32) (after analysis: type of analysis done): 1 INFOG(33) (value used for ICNTL(8)): 7 INFOG(34) (exponent of the determinant if determinant is requested): 0 linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=20, cols=20, bs=2 total: nonzeros=112, allocated nonzeros=240 total number of mallocs used during MatSetValues calls =0 Ellen On Tue, Aug 21, 2018 at 10:16 PM Matthew Knepley wrote: > On Tue, Aug 21, 2018 at 10:00 PM Ellen M. Price < > ellen.price at cfa.harvard.edu> wrote: > >> Hi PETSc users, >> >> I'm having trouble applying SNES to a new problem I'm working on. I'll >> try to be as complete as possible but can't post the full code because >> it's ongoing research and is pretty long anyway. >> >> The nonlinear problem arises from trying to solve a set of two coupled >> ODEs using a Galerkin method. I am using Mathematica to generate the >> objective function to solve and the Jacobian, so I *think* I can rule >> out human error on that front. >> >> There are four things I can easily change: >> >> - number of DMDA grid points N (I've tried 100 and 1000) >> - preconditioner (I've tried LU and SVD, LU appears to work better, and >> SVD is too slow for N = 1000) >> - linear solver (haven't played with this much, but sometimes smaller >> tolerances work better) >> - nonlinear solver (what I'm having trouble with) >> >> Trying different solvers should, as far as I'm aware, give comparable >> answers, but that's not the case here. NEWTONTR works best of the ones >> I've tried, but I'm suspicious that the function value barely decreases >> before SNES "converges" -- and none of the options I've tried changing >> seem to affect this, as it just finds another reason to converge without >> making any real progress. For example: >> >> 0 SNES Function norm 7.197788479418e+00 >> 0 KSP Residual norm 1.721996766619e+01 >> 1 KSP Residual norm 5.186021549059e-14 >> Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 >> > > This makes no sense. LU should converge due to atol or rtol. Send the > output of > > -snes_view -snes_monitor -snes_converged_reason > -ksp_monitor_true_residual -ksp_converged_reason > > Thanks, > > Matt > > >> 1 SNES Function norm 7.197777674987e+00 >> 0 KSP Residual norm 3.296112185897e+01 >> 1 KSP Residual norm 2.713415432045e-13 >> Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 >> ..... >> 50 SNES Function norm 7.197376803542e+00 >> 0 KSP Residual norm 6.222518656302e+02 >> 1 KSP Residual norm 9.630659996504e-12 >> Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 >> 51 SNES Function norm 7.197376803542e+00 >> Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 >> >> I've tried everything I can think of and the FAQ suggestions, including >> non-dimensionalizing the problem; I observe the same behavior either >> way. The particularly strange thing I can't understand is why some of >> the SNES methods fail outright, after just one iteration (NCG, NGMRES, >> and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems >> like, for the most part, I should be able to substitute in one method >> for another, possibly adjusting a few parameters along the way. >> Furthermore, the default method, NEWTONLS, diverges with >> DIVERGED_LINE_SEARCH, which I'm not sure how to debug. >> >> So the only viable method is NEWTONTR, and that doesn't appear to >> "really" converge. Any suggestions for further things to try are >> appreciated. My current options are: >> >> -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason >> -snes_max_it 10000 -ksp_monitor -snes_type newtonls >> >> Thanks in advance, >> Ellen Price >> > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > -------------- next part -------------- An HTML attachment was scrubbed... URL: From Ling.Zou at inl.gov Wed Aug 22 12:46:02 2018 From: Ling.Zou at inl.gov (Ling Zou) Date: Wed, 22 Aug 2018 17:46:02 +0000 Subject: [petsc-users] Debugging SNES when "everything" looks okay In-Reply-To: References: , Message-ID: I think your Jacobian is good enough, otherwise you won't achieve one step KSP convergence using '-pc_type lu'. Are you using matrix free? If so, could try: '-mat_mffd_type ds -mat_fd_type ds' -Ling ________________________________ From: petsc-users on behalf of Ellen Price Sent: Wednesday, August 22, 2018 11:33:18 AM To: Matthew Knepley; Smith, Barry F. Cc: PETSc Subject: Re: [petsc-users] Debugging SNES when "everything" looks okay For Barry: Okay, I'm stumped. Some of my Jacobian terms match up with the finite difference one. Others are off by orders of magnitude. This led me to think that maybe there was something wrong with my analytic Jacobian, so I went back and started trying to track down which term causes the problem. The weird thing is that Mathematica gives the same numerical result as my code (within a small tolerance), whether i substitute numbers into its analytic Jacobian or numerically differentiate the function I'm trying to solve using Mathematica. I can't think of anything else to try for debugging the Jacobian. Even if the function has a bug in it, Mathematica seems pretty sure that I'm using the right Jacobian for what I put in... At the suggestion of the FAQ, I also tried "-mat_fd_type ds" to see if that made any difference, but it doesn't. Like I said, I'm stumped, but I'll keep trying. For Matt: Using options "-pc_type lu -snes_view -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason -snes_type newtontr", the output is below. I thought that the step length convergence message had something to do with using NEWTONTR, but I could be wrong about that. It doesn't give that message when I switch to NEWTONLS. It also only gives that message after the first iteration -- the first one is always CONVERGED_RTOL. 7.533921e-03, 2.054699e+02 0 SNES Function norm 6.252612941119e+04 0 KSP preconditioned resid norm 1.027204021595e-01 true resid norm 6.252612941119e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.641617517320e-17 true resid norm 3.941610607093e-11 ||r(i)||/||b|| 6.303941478885e-16 Linear solve converged due to CONVERGED_RTOL iterations 1 1 SNES Function norm 6.252085930204e+04 0 KSP preconditioned resid norm 3.857372064539e-01 true resid norm 6.252085930204e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.664921095158e-16 true resid norm 2.434875289829e-10 ||r(i)||/||b|| 3.894500678672e-15 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 2 SNES Function norm 6.251886926050e+04 0 KSP preconditioned resid norm 4.085000006938e-01 true resid norm 6.251886926050e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 5.318519617927e-16 true resid norm 8.189931340015e-10 ||r(i)||/||b|| 1.309993516660e-14 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 ..... 48 SNES Function norm 6.229932776333e+04 0 KSP preconditioned resid norm 4.872526135345e+00 true resid norm 6.229932776333e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 7.281571852581e-15 true resid norm 8.562155918387e-09 ||r(i)||/||b|| 1.374357673796e-13 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 49 SNES Function norm 6.229663411026e+04 0 KSP preconditioned resid norm 4.953303401996e+00 true resid norm 6.229663411026e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.537319689814e-15 true resid norm 4.783442569088e-09 ||r(i)||/||b|| 7.678492806886e-14 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 50 SNES Function norm 6.229442686875e+04 Nonlinear solve did not converge due to DIVERGED_MAX_IT iterations 50 SNES Object: 2 MPI processes type: newtontr Trust region tolerance (-snes_trtol) mu=0.25, eta=0.75, sigma=0.0001 delta0=0.2, delta1=0.3, delta2=0.75, delta3=2. maximum iterations=50, maximum function evaluations=10000 tolerances: relative=1e-08, absolute=1e-50, solution=1e-08 total number of linear solver iterations=50 total number of function evaluations=58 norm schedule ALWAYS SNESLineSearch Object: 2 MPI processes type: basic maxstep=1.000000e+08, minlambda=1.000000e-12 tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 maximum iterations=1 KSP Object: 2 MPI processes type: gmres restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement happy breakdown tolerance 1e-30 maximum iterations=10000, initial guess is zero tolerances: relative=1e-05, absolute=1e-50, divergence=10000. left preconditioning using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: lu out-of-place factorization tolerance for zero pivot 2.22045e-14 matrix ordering: natural factor fill ratio given 0., needed 0. Factored matrix follows: Mat Object: 2 MPI processes type: mumps rows=20, cols=20 package used to perform factorization: mumps total: nonzeros=112, allocated nonzeros=112 total number of mallocs used during MatSetValues calls =0 MUMPS run parameters: SYM (matrix type): 0 PAR (host participation): 1 ICNTL(1) (output for error): 6 ICNTL(2) (output of diagnostic msg): 0 ICNTL(3) (output for global info): 0 ICNTL(4) (level of printing): 0 ICNTL(5) (input mat struct): 0 ICNTL(6) (matrix prescaling): 7 ICNTL(7) (sequential matrix ordering):7 ICNTL(8) (scaling strategy): 77 ICNTL(10) (max num of refinements): 0 ICNTL(11) (error analysis): 0 ICNTL(12) (efficiency control): 1 ICNTL(13) (efficiency control): 0 ICNTL(14) (percentage of estimated workspace increase): 20 ICNTL(18) (input mat struct): 3 ICNTL(19) (Schur complement info): 0 ICNTL(20) (rhs sparse pattern): 0 ICNTL(21) (solution struct): 1 ICNTL(22) (in-core/out-of-core facility): 0 ICNTL(23) (max size of memory can be allocated locally):0 ICNTL(24) (detection of null pivot rows): 0 ICNTL(25) (computation of a null space basis): 0 ICNTL(26) (Schur options for rhs or solution): 0 ICNTL(27) (experimental parameter): -32 ICNTL(28) (use parallel or sequential ordering): 1 ICNTL(29) (parallel ordering): 0 ICNTL(30) (user-specified set of entries in inv(A)): 0 ICNTL(31) (factors is discarded in the solve phase): 0 ICNTL(33) (compute determinant): 0 ICNTL(35) (activate BLR based factorization): 0 CNTL(1) (relative pivoting threshold): 0.01 CNTL(2) (stopping criterion of refinement): 1.49012e-08 CNTL(3) (absolute pivoting threshold): 0. CNTL(4) (value of static pivoting): -1. CNTL(5) (fixation for null pivots): 0. CNTL(7) (dropping parameter for BLR): 0. RINFO(1) (local estimated flops for the elimination after analysis): [0] 127. [1] 155. RINFO(2) (local estimated flops for the assembly after factorization): [0] 16. [1] 16. RINFO(3) (local estimated flops for the elimination after factorization): [0] 127. [1] 155. INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 1 [1] 1 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 1 [1] 1 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 10 [1] 10 RINFOG(1) (global estimated flops for the elimination after analysis): 282. RINFOG(2) (global estimated flops for the assembly after factorization): 32. RINFOG(3) (global estimated flops for the elimination after factorization): 282. (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 112 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 225 INFOG(5) (estimated maximum front size in the complete tree): 4 INFOG(6) (number of nodes in the complete tree): 9 INFOG(7) (ordering option effectively use after analysis): 2 INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 112 INFOG(10) (total integer space store the matrix factors after factorization): 225 INFOG(11) (order of largest frontal matrix after factorization): 4 INFOG(12) (number of off-diagonal pivots): 0 INFOG(13) (number of delayed pivots after factorization): 0 INFOG(14) (number of memory compress after factorization): 0 INFOG(15) (number of steps of iterative refinement after solution): 0 INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 1 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 2 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 1 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 2 INFOG(20) (estimated number of entries in the factors): 112 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 1 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 2 INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 INFOG(28) (after factorization: number of null pivots encountered): 0 INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 112 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 0, 0 INFOG(32) (after analysis: type of analysis done): 1 INFOG(33) (value used for ICNTL(8)): 7 INFOG(34) (exponent of the determinant if determinant is requested): 0 linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=20, cols=20, bs=2 total: nonzeros=112, allocated nonzeros=240 total number of mallocs used during MatSetValues calls =0 Ellen On Tue, Aug 21, 2018 at 10:16 PM Matthew Knepley > wrote: On Tue, Aug 21, 2018 at 10:00 PM Ellen M. Price > wrote: Hi PETSc users, I'm having trouble applying SNES to a new problem I'm working on. I'll try to be as complete as possible but can't post the full code because it's ongoing research and is pretty long anyway. The nonlinear problem arises from trying to solve a set of two coupled ODEs using a Galerkin method. I am using Mathematica to generate the objective function to solve and the Jacobian, so I *think* I can rule out human error on that front. There are four things I can easily change: - number of DMDA grid points N (I've tried 100 and 1000) - preconditioner (I've tried LU and SVD, LU appears to work better, and SVD is too slow for N = 1000) - linear solver (haven't played with this much, but sometimes smaller tolerances work better) - nonlinear solver (what I'm having trouble with) Trying different solvers should, as far as I'm aware, give comparable answers, but that's not the case here. NEWTONTR works best of the ones I've tried, but I'm suspicious that the function value barely decreases before SNES "converges" -- and none of the options I've tried changing seem to affect this, as it just finds another reason to converge without making any real progress. For example: 0 SNES Function norm 7.197788479418e+00 0 KSP Residual norm 1.721996766619e+01 1 KSP Residual norm 5.186021549059e-14 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 This makes no sense. LU should converge due to atol or rtol. Send the output of -snes_view -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason Thanks, Matt 1 SNES Function norm 7.197777674987e+00 0 KSP Residual norm 3.296112185897e+01 1 KSP Residual norm 2.713415432045e-13 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 ..... 50 SNES Function norm 7.197376803542e+00 0 KSP Residual norm 6.222518656302e+02 1 KSP Residual norm 9.630659996504e-12 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 51 SNES Function norm 7.197376803542e+00 Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 I've tried everything I can think of and the FAQ suggestions, including non-dimensionalizing the problem; I observe the same behavior either way. The particularly strange thing I can't understand is why some of the SNES methods fail outright, after just one iteration (NCG, NGMRES, and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems like, for the most part, I should be able to substitute in one method for another, possibly adjusting a few parameters along the way. Furthermore, the default method, NEWTONLS, diverges with DIVERGED_LINE_SEARCH, which I'm not sure how to debug. So the only viable method is NEWTONTR, and that doesn't appear to "really" converge. Any suggestions for further things to try are appreciated. My current options are: -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason -snes_max_it 10000 -ksp_monitor -snes_type newtonls Thanks in advance, Ellen Price -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From Ling.Zou at inl.gov Wed Aug 22 12:58:51 2018 From: Ling.Zou at inl.gov (Ling Zou) Date: Wed, 22 Aug 2018 17:58:51 +0000 Subject: [petsc-users] Debugging SNES when "everything" looks okay In-Reply-To: References: , , Message-ID: Back to your original post, you mentioned that you played with NEWTONLS while having DIVERGED_LINE_SEARCH error. You could play with other line search options such as 'basic'. I remember sometimes it helps. NEWTONLS could be combined with '-mat_mffd_type ds -mat_fd_type ds' http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/SNES/SNESLineSearchSetType.html -Ling SNESLineSearchSetType - mcs.anl.gov www.mcs.anl.gov Options Database-snes_linesearch_type -basic, bt, l2, cp, nleqerr, shell See Also SNESLineSearchCreate(), SNESLineSearchType, SNESLineSearchSetFromOptions() . Level ... ________________________________ From: petsc-users on behalf of Ling Zou Sent: Wednesday, August 22, 2018 11:46:02 AM To: Ellen Price; Matthew Knepley; Smith, Barry F. Cc: PETSc Subject: Re: [petsc-users] Debugging SNES when "everything" looks okay I think your Jacobian is good enough, otherwise you won't achieve one step KSP convergence using '-pc_type lu'. Are you using matrix free? If so, could try: '-mat_mffd_type ds -mat_fd_type ds' -Ling ________________________________ From: petsc-users on behalf of Ellen Price Sent: Wednesday, August 22, 2018 11:33:18 AM To: Matthew Knepley; Smith, Barry F. Cc: PETSc Subject: Re: [petsc-users] Debugging SNES when "everything" looks okay For Barry: Okay, I'm stumped. Some of my Jacobian terms match up with the finite difference one. Others are off by orders of magnitude. This led me to think that maybe there was something wrong with my analytic Jacobian, so I went back and started trying to track down which term causes the problem. The weird thing is that Mathematica gives the same numerical result as my code (within a small tolerance), whether i substitute numbers into its analytic Jacobian or numerically differentiate the function I'm trying to solve using Mathematica. I can't think of anything else to try for debugging the Jacobian. Even if the function has a bug in it, Mathematica seems pretty sure that I'm using the right Jacobian for what I put in... At the suggestion of the FAQ, I also tried "-mat_fd_type ds" to see if that made any difference, but it doesn't. Like I said, I'm stumped, but I'll keep trying. For Matt: Using options "-pc_type lu -snes_view -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason -snes_type newtontr", the output is below. I thought that the step length convergence message had something to do with using NEWTONTR, but I could be wrong about that. It doesn't give that message when I switch to NEWTONLS. It also only gives that message after the first iteration -- the first one is always CONVERGED_RTOL. 7.533921e-03, 2.054699e+02 0 SNES Function norm 6.252612941119e+04 0 KSP preconditioned resid norm 1.027204021595e-01 true resid norm 6.252612941119e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.641617517320e-17 true resid norm 3.941610607093e-11 ||r(i)||/||b|| 6.303941478885e-16 Linear solve converged due to CONVERGED_RTOL iterations 1 1 SNES Function norm 6.252085930204e+04 0 KSP preconditioned resid norm 3.857372064539e-01 true resid norm 6.252085930204e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.664921095158e-16 true resid norm 2.434875289829e-10 ||r(i)||/||b|| 3.894500678672e-15 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 2 SNES Function norm 6.251886926050e+04 0 KSP preconditioned resid norm 4.085000006938e-01 true resid norm 6.251886926050e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 5.318519617927e-16 true resid norm 8.189931340015e-10 ||r(i)||/||b|| 1.309993516660e-14 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 ..... 48 SNES Function norm 6.229932776333e+04 0 KSP preconditioned resid norm 4.872526135345e+00 true resid norm 6.229932776333e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 7.281571852581e-15 true resid norm 8.562155918387e-09 ||r(i)||/||b|| 1.374357673796e-13 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 49 SNES Function norm 6.229663411026e+04 0 KSP preconditioned resid norm 4.953303401996e+00 true resid norm 6.229663411026e+04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.537319689814e-15 true resid norm 4.783442569088e-09 ||r(i)||/||b|| 7.678492806886e-14 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 50 SNES Function norm 6.229442686875e+04 Nonlinear solve did not converge due to DIVERGED_MAX_IT iterations 50 SNES Object: 2 MPI processes type: newtontr Trust region tolerance (-snes_trtol) mu=0.25, eta=0.75, sigma=0.0001 delta0=0.2, delta1=0.3, delta2=0.75, delta3=2. maximum iterations=50, maximum function evaluations=10000 tolerances: relative=1e-08, absolute=1e-50, solution=1e-08 total number of linear solver iterations=50 total number of function evaluations=58 norm schedule ALWAYS SNESLineSearch Object: 2 MPI processes type: basic maxstep=1.000000e+08, minlambda=1.000000e-12 tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 maximum iterations=1 KSP Object: 2 MPI processes type: gmres restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement happy breakdown tolerance 1e-30 maximum iterations=10000, initial guess is zero tolerances: relative=1e-05, absolute=1e-50, divergence=10000. left preconditioning using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: lu out-of-place factorization tolerance for zero pivot 2.22045e-14 matrix ordering: natural factor fill ratio given 0., needed 0. Factored matrix follows: Mat Object: 2 MPI processes type: mumps rows=20, cols=20 package used to perform factorization: mumps total: nonzeros=112, allocated nonzeros=112 total number of mallocs used during MatSetValues calls =0 MUMPS run parameters: SYM (matrix type): 0 PAR (host participation): 1 ICNTL(1) (output for error): 6 ICNTL(2) (output of diagnostic msg): 0 ICNTL(3) (output for global info): 0 ICNTL(4) (level of printing): 0 ICNTL(5) (input mat struct): 0 ICNTL(6) (matrix prescaling): 7 ICNTL(7) (sequential matrix ordering):7 ICNTL(8) (scaling strategy): 77 ICNTL(10) (max num of refinements): 0 ICNTL(11) (error analysis): 0 ICNTL(12) (efficiency control): 1 ICNTL(13) (efficiency control): 0 ICNTL(14) (percentage of estimated workspace increase): 20 ICNTL(18) (input mat struct): 3 ICNTL(19) (Schur complement info): 0 ICNTL(20) (rhs sparse pattern): 0 ICNTL(21) (solution struct): 1 ICNTL(22) (in-core/out-of-core facility): 0 ICNTL(23) (max size of memory can be allocated locally):0 ICNTL(24) (detection of null pivot rows): 0 ICNTL(25) (computation of a null space basis): 0 ICNTL(26) (Schur options for rhs or solution): 0 ICNTL(27) (experimental parameter): -32 ICNTL(28) (use parallel or sequential ordering): 1 ICNTL(29) (parallel ordering): 0 ICNTL(30) (user-specified set of entries in inv(A)): 0 ICNTL(31) (factors is discarded in the solve phase): 0 ICNTL(33) (compute determinant): 0 ICNTL(35) (activate BLR based factorization): 0 CNTL(1) (relative pivoting threshold): 0.01 CNTL(2) (stopping criterion of refinement): 1.49012e-08 CNTL(3) (absolute pivoting threshold): 0. CNTL(4) (value of static pivoting): -1. CNTL(5) (fixation for null pivots): 0. CNTL(7) (dropping parameter for BLR): 0. RINFO(1) (local estimated flops for the elimination after analysis): [0] 127. [1] 155. RINFO(2) (local estimated flops for the assembly after factorization): [0] 16. [1] 16. RINFO(3) (local estimated flops for the elimination after factorization): [0] 127. [1] 155. INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 1 [1] 1 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 1 [1] 1 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 10 [1] 10 RINFOG(1) (global estimated flops for the elimination after analysis): 282. RINFOG(2) (global estimated flops for the assembly after factorization): 32. RINFOG(3) (global estimated flops for the elimination after factorization): 282. (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 112 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 225 INFOG(5) (estimated maximum front size in the complete tree): 4 INFOG(6) (number of nodes in the complete tree): 9 INFOG(7) (ordering option effectively use after analysis): 2 INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 112 INFOG(10) (total integer space store the matrix factors after factorization): 225 INFOG(11) (order of largest frontal matrix after factorization): 4 INFOG(12) (number of off-diagonal pivots): 0 INFOG(13) (number of delayed pivots after factorization): 0 INFOG(14) (number of memory compress after factorization): 0 INFOG(15) (number of steps of iterative refinement after solution): 0 INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 1 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 2 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 1 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 2 INFOG(20) (estimated number of entries in the factors): 112 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 1 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 2 INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 INFOG(28) (after factorization: number of null pivots encountered): 0 INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 112 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 0, 0 INFOG(32) (after analysis: type of analysis done): 1 INFOG(33) (value used for ICNTL(8)): 7 INFOG(34) (exponent of the determinant if determinant is requested): 0 linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=20, cols=20, bs=2 total: nonzeros=112, allocated nonzeros=240 total number of mallocs used during MatSetValues calls =0 Ellen On Tue, Aug 21, 2018 at 10:16 PM Matthew Knepley > wrote: On Tue, Aug 21, 2018 at 10:00 PM Ellen M. Price > wrote: Hi PETSc users, I'm having trouble applying SNES to a new problem I'm working on. I'll try to be as complete as possible but can't post the full code because it's ongoing research and is pretty long anyway. The nonlinear problem arises from trying to solve a set of two coupled ODEs using a Galerkin method. I am using Mathematica to generate the objective function to solve and the Jacobian, so I *think* I can rule out human error on that front. There are four things I can easily change: - number of DMDA grid points N (I've tried 100 and 1000) - preconditioner (I've tried LU and SVD, LU appears to work better, and SVD is too slow for N = 1000) - linear solver (haven't played with this much, but sometimes smaller tolerances work better) - nonlinear solver (what I'm having trouble with) Trying different solvers should, as far as I'm aware, give comparable answers, but that's not the case here. NEWTONTR works best of the ones I've tried, but I'm suspicious that the function value barely decreases before SNES "converges" -- and none of the options I've tried changing seem to affect this, as it just finds another reason to converge without making any real progress. For example: 0 SNES Function norm 7.197788479418e+00 0 KSP Residual norm 1.721996766619e+01 1 KSP Residual norm 5.186021549059e-14 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 This makes no sense. LU should converge due to atol or rtol. Send the output of -snes_view -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason Thanks, Matt 1 SNES Function norm 7.197777674987e+00 0 KSP Residual norm 3.296112185897e+01 1 KSP Residual norm 2.713415432045e-13 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 ..... 50 SNES Function norm 7.197376803542e+00 0 KSP Residual norm 6.222518656302e+02 1 KSP Residual norm 9.630659996504e-12 Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 51 SNES Function norm 7.197376803542e+00 Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 I've tried everything I can think of and the FAQ suggestions, including non-dimensionalizing the problem; I observe the same behavior either way. The particularly strange thing I can't understand is why some of the SNES methods fail outright, after just one iteration (NCG, NGMRES, and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems like, for the most part, I should be able to substitute in one method for another, possibly adjusting a few parameters along the way. Furthermore, the default method, NEWTONLS, diverges with DIVERGED_LINE_SEARCH, which I'm not sure how to debug. So the only viable method is NEWTONTR, and that doesn't appear to "really" converge. Any suggestions for further things to try are appreciated. My current options are: -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason -snes_max_it 10000 -ksp_monitor -snes_type newtonls Thanks in advance, Ellen Price -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 22 13:19:41 2018 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 22 Aug 2018 14:19:41 -0400 Subject: [petsc-users] Debugging SNES when "everything" looks okay In-Reply-To: References: Message-ID: On Wed, Aug 22, 2018 at 1:33 PM Ellen Price wrote: > For Barry: > > Okay, I'm stumped. Some of my Jacobian terms match up with the finite > difference one. Others are off by orders of magnitude. > Then your Jacobian does not match your function. This is easy to track down: 1) Reduce your problem size to 10 or so. Lots of people try to avoid doing this, but that is crazy. Always have a problem of size 10. 2) PETSc uses the all ones (1, 1, ..., 1) and all minus ones (-1, -1, ..., -1) states to check the Jacobian. Feed those into your PETSc function and your Mathematics function. Do you get the same vector out? 3) Feed them into your PETSc Jacobian and Mathematics Jacobian. Do you get the same matrix out? There is nothing mystical here. PETSc is saying that the analytic Jacobian must match finite differences in the limit. Matt > This led me to think that maybe there was something wrong with my analytic > Jacobian, so I went back and started trying to track down which term causes > the problem. The weird thing is that Mathematica gives the same numerical > result as my code (within a small tolerance), whether i substitute numbers > into its analytic Jacobian or numerically differentiate the function I'm > trying to solve using Mathematica. I can't think of anything else to try > for debugging the Jacobian. Even if the function has a bug in it, > Mathematica seems pretty sure that I'm using the right Jacobian for what I > put in... At the suggestion of the FAQ, I also tried "-mat_fd_type ds" to > see if that made any difference, but it doesn't. Like I said, I'm stumped, > but I'll keep trying. > > For Matt: > > Using options "-pc_type lu -snes_view -snes_monitor -snes_converged_reason > -ksp_monitor_true_residual -ksp_converged_reason -snes_type newtontr", the > output is below. I thought that the step length convergence message had > something to do with using NEWTONTR, but I could be wrong about that. It > doesn't give that message when I switch to NEWTONLS. It also only gives > that message after the first iteration -- the first one is always > CONVERGED_RTOL. > > 7.533921e-03, 2.054699e+02 > 0 SNES Function norm 6.252612941119e+04 > 0 KSP preconditioned resid norm 1.027204021595e-01 true resid norm > 6.252612941119e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.641617517320e-17 true resid norm > 3.941610607093e-11 ||r(i)||/||b|| 6.303941478885e-16 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 1 SNES Function norm 6.252085930204e+04 > 0 KSP preconditioned resid norm 3.857372064539e-01 true resid norm > 6.252085930204e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.664921095158e-16 true resid norm > 2.434875289829e-10 ||r(i)||/||b|| 3.894500678672e-15 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 2 SNES Function norm 6.251886926050e+04 > 0 KSP preconditioned resid norm 4.085000006938e-01 true resid norm > 6.251886926050e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.318519617927e-16 true resid norm > 8.189931340015e-10 ||r(i)||/||b|| 1.309993516660e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > ..... > 48 SNES Function norm 6.229932776333e+04 > 0 KSP preconditioned resid norm 4.872526135345e+00 true resid norm > 6.229932776333e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.281571852581e-15 true resid norm > 8.562155918387e-09 ||r(i)||/||b|| 1.374357673796e-13 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 49 SNES Function norm 6.229663411026e+04 > 0 KSP preconditioned resid norm 4.953303401996e+00 true resid norm > 6.229663411026e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.537319689814e-15 true resid norm > 4.783442569088e-09 ||r(i)||/||b|| 7.678492806886e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 50 SNES Function norm 6.229442686875e+04 > Nonlinear solve did not converge due to DIVERGED_MAX_IT iterations 50 > SNES Object: 2 MPI processes > type: newtontr > Trust region tolerance (-snes_trtol) > mu=0.25, eta=0.75, sigma=0.0001 > delta0=0.2, delta1=0.3, delta2=0.75, delta3=2. > maximum iterations=50, maximum function evaluations=10000 > tolerances: relative=1e-08, absolute=1e-50, solution=1e-08 > total number of linear solver iterations=50 > total number of function evaluations=58 > norm schedule ALWAYS > SNESLineSearch Object: 2 MPI processes > type: basic > maxstep=1.000000e+08, minlambda=1.000000e-12 > tolerances: relative=1.000000e-08, absolute=1.000000e-15, > lambda=1.000000e-08 > maximum iterations=1 > KSP Object: 2 MPI processes > type: gmres > restart=30, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > happy breakdown tolerance 1e-30 > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: 2 MPI processes > type: lu > out-of-place factorization > tolerance for zero pivot 2.22045e-14 > matrix ordering: natural > factor fill ratio given 0., needed 0. > Factored matrix follows: > Mat Object: 2 MPI processes > type: mumps > rows=20, cols=20 > package used to perform factorization: mumps > total: nonzeros=112, allocated nonzeros=112 > total number of mallocs used during MatSetValues calls =0 > MUMPS run parameters: > SYM (matrix type): 0 > PAR (host participation): 1 > ICNTL(1) (output for error): 6 > ICNTL(2) (output of diagnostic msg): 0 > ICNTL(3) (output for global info): 0 > ICNTL(4) (level of printing): 0 > ICNTL(5) (input mat struct): 0 > ICNTL(6) (matrix prescaling): 7 > ICNTL(7) (sequential matrix ordering):7 > ICNTL(8) (scaling strategy): 77 > ICNTL(10) (max num of refinements): 0 > ICNTL(11) (error analysis): 0 > ICNTL(12) (efficiency control): 1 > ICNTL(13) (efficiency control): 0 > ICNTL(14) (percentage of estimated workspace increase): 20 > ICNTL(18) (input mat struct): 3 > ICNTL(19) (Schur complement info): 0 > ICNTL(20) (rhs sparse pattern): 0 > ICNTL(21) (solution struct): 1 > ICNTL(22) (in-core/out-of-core facility): 0 > ICNTL(23) (max size of memory can be allocated locally):0 > ICNTL(24) (detection of null pivot rows): 0 > ICNTL(25) (computation of a null space basis): 0 > ICNTL(26) (Schur options for rhs or solution): 0 > ICNTL(27) (experimental parameter): > -32 > ICNTL(28) (use parallel or sequential ordering): 1 > ICNTL(29) (parallel ordering): 0 > ICNTL(30) (user-specified set of entries in inv(A)): 0 > ICNTL(31) (factors is discarded in the solve phase): 0 > ICNTL(33) (compute determinant): 0 > ICNTL(35) (activate BLR based factorization): 0 > CNTL(1) (relative pivoting threshold): 0.01 > CNTL(2) (stopping criterion of refinement): 1.49012e-08 > CNTL(3) (absolute pivoting threshold): 0. > CNTL(4) (value of static pivoting): -1. > CNTL(5) (fixation for null pivots): 0. > CNTL(7) (dropping parameter for BLR): 0. > RINFO(1) (local estimated flops for the elimination after > analysis): > [0] 127. > [1] 155. > RINFO(2) (local estimated flops for the assembly after > factorization): > [0] 16. > [1] 16. > RINFO(3) (local estimated flops for the elimination after > factorization): > [0] 127. > [1] 155. > INFO(15) (estimated size of (in MB) MUMPS internal data > for running numerical factorization): > [0] 1 > [1] 1 > INFO(16) (size of (in MB) MUMPS internal data used during > numerical factorization): > [0] 1 > [1] 1 > INFO(23) (num of pivots eliminated on this processor after > factorization): > [0] 10 > [1] 10 > RINFOG(1) (global estimated flops for the elimination > after analysis): 282. > RINFOG(2) (global estimated flops for the assembly after > factorization): 32. > RINFOG(3) (global estimated flops for the elimination > after factorization): 282. > (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): > (0.,0.)*(2^0) > INFOG(3) (estimated real workspace for factors on all > processors after analysis): 112 > INFOG(4) (estimated integer workspace for factors on all > processors after analysis): 225 > INFOG(5) (estimated maximum front size in the complete > tree): 4 > INFOG(6) (number of nodes in the complete tree): 9 > INFOG(7) (ordering option effectively use after analysis): > 2 > INFOG(8) (structural symmetry in percent of the permuted > matrix after analysis): 100 > INFOG(9) (total real/complex workspace to store the matrix > factors after factorization): 112 > INFOG(10) (total integer space store the matrix factors > after factorization): 225 > INFOG(11) (order of largest frontal matrix after > factorization): 4 > INFOG(12) (number of off-diagonal pivots): 0 > INFOG(13) (number of delayed pivots after factorization): > 0 > INFOG(14) (number of memory compress after factorization): > 0 > INFOG(15) (number of steps of iterative refinement after > solution): 0 > INFOG(16) (estimated size (in MB) of all MUMPS internal > data for factorization after analysis: value on the most memory consuming > processor): 1 > INFOG(17) (estimated size of all MUMPS internal data for > factorization after analysis: sum over all processors): 2 > INFOG(18) (size of all MUMPS internal data allocated > during factorization: value on the most memory consuming processor): 1 > INFOG(19) (size of all MUMPS internal data allocated > during factorization: sum over all processors): 2 > INFOG(20) (estimated number of entries in the factors): > 112 > INFOG(21) (size in MB of memory effectively used during > factorization - value on the most memory consuming processor): 1 > INFOG(22) (size in MB of memory effectively used during > factorization - sum over all processors): 2 > INFOG(23) (after analysis: value of ICNTL(6) effectively > used): 0 > INFOG(24) (after analysis: value of ICNTL(12) effectively > used): 1 > INFOG(25) (after factorization: number of pivots modified > by static pivoting): 0 > INFOG(28) (after factorization: number of null pivots > encountered): 0 > INFOG(29) (after factorization: effective number of > entries in the factors (sum over all processors)): 112 > INFOG(30, 31) (after solution: size in Mbytes of memory > used during solution phase): 0, 0 > INFOG(32) (after analysis: type of analysis done): 1 > INFOG(33) (value used for ICNTL(8)): 7 > INFOG(34) (exponent of the determinant if determinant is > requested): 0 > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaij > rows=20, cols=20, bs=2 > total: nonzeros=112, allocated nonzeros=240 > total number of mallocs used during MatSetValues calls =0 > > Ellen > > On Tue, Aug 21, 2018 at 10:16 PM Matthew Knepley > wrote: > >> On Tue, Aug 21, 2018 at 10:00 PM Ellen M. Price < >> ellen.price at cfa.harvard.edu> wrote: >> >>> Hi PETSc users, >>> >>> I'm having trouble applying SNES to a new problem I'm working on. I'll >>> try to be as complete as possible but can't post the full code because >>> it's ongoing research and is pretty long anyway. >>> >>> The nonlinear problem arises from trying to solve a set of two coupled >>> ODEs using a Galerkin method. I am using Mathematica to generate the >>> objective function to solve and the Jacobian, so I *think* I can rule >>> out human error on that front. >>> >>> There are four things I can easily change: >>> >>> - number of DMDA grid points N (I've tried 100 and 1000) >>> - preconditioner (I've tried LU and SVD, LU appears to work better, and >>> SVD is too slow for N = 1000) >>> - linear solver (haven't played with this much, but sometimes smaller >>> tolerances work better) >>> - nonlinear solver (what I'm having trouble with) >>> >>> Trying different solvers should, as far as I'm aware, give comparable >>> answers, but that's not the case here. NEWTONTR works best of the ones >>> I've tried, but I'm suspicious that the function value barely decreases >>> before SNES "converges" -- and none of the options I've tried changing >>> seem to affect this, as it just finds another reason to converge without >>> making any real progress. For example: >>> >>> 0 SNES Function norm 7.197788479418e+00 >>> 0 KSP Residual norm 1.721996766619e+01 >>> 1 KSP Residual norm 5.186021549059e-14 >>> Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 >>> >> >> This makes no sense. LU should converge due to atol or rtol. Send the >> output of >> >> -snes_view -snes_monitor -snes_converged_reason >> -ksp_monitor_true_residual -ksp_converged_reason >> >> Thanks, >> >> Matt >> >> >>> 1 SNES Function norm 7.197777674987e+00 >>> 0 KSP Residual norm 3.296112185897e+01 >>> 1 KSP Residual norm 2.713415432045e-13 >>> Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 >>> ..... >>> 50 SNES Function norm 7.197376803542e+00 >>> 0 KSP Residual norm 6.222518656302e+02 >>> 1 KSP Residual norm 9.630659996504e-12 >>> Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 >>> 51 SNES Function norm 7.197376803542e+00 >>> Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 >>> >>> I've tried everything I can think of and the FAQ suggestions, including >>> non-dimensionalizing the problem; I observe the same behavior either >>> way. The particularly strange thing I can't understand is why some of >>> the SNES methods fail outright, after just one iteration (NCG, NGMRES, >>> and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems >>> like, for the most part, I should be able to substitute in one method >>> for another, possibly adjusting a few parameters along the way. >>> Furthermore, the default method, NEWTONLS, diverges with >>> DIVERGED_LINE_SEARCH, which I'm not sure how to debug. >>> >>> So the only viable method is NEWTONTR, and that doesn't appear to >>> "really" converge. Any suggestions for further things to try are >>> appreciated. My current options are: >>> >>> -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason >>> -snes_max_it 10000 -ksp_monitor -snes_type newtonls >>> >>> Thanks in advance, >>> Ellen Price >>> >> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From zakaryah at gmail.com Wed Aug 22 13:23:42 2018 From: zakaryah at gmail.com (zakaryah) Date: Wed, 22 Aug 2018 14:23:42 -0400 Subject: [petsc-users] Debugging SNES when "everything" looks okay In-Reply-To: References: Message-ID: In my experience, when debugging issues with convergence of nonlinear solvers, it's very important to be sure that the Jacobian is correct. When you say there are terms which differ by orders of magnitude, can you be more precise? Are those differences significant relative to the magnitude of typical nonzero entries in the Jacobian? If not, they could be due to truncation error, since the finite difference is a linear approximation. If the differences are significant, is there anything special about where in your DMDA they appear? Errors in implementing boundary conditions are common. >From your log, it looks like you are not having any problems with the linear solver. Assuming your Jacobian is correct, it could be, as Barry says, that Newton's method fails to converge because your initial guess is not in the basin of attraction of a root. From the way your residual stagnates, it looks like this could be happening - the solver could be stuck at a point where the Jacobian is singular or nearly singular. You should be able to check this, since your problem is small enough to use LU decomposition. If that is the case, there are many things you might try for improving convergence. The particularly strange thing I can't understand is why some of > the SNES methods fail outright, after just one iteration (NCG, NGMRES, > and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems > like, for the most part, I should be able to substitute in one method > for another, possibly adjusting a few parameters along the way. I don't think you can think about the methods this way. There are fundamental differences between them. For example, nonlinear conjugate gradient assumes a quadratic function, so it won't necessarily work well if your Jacobian is not symmetric and positive definite (is it?). I find that debugging by starting with Newton's method and linesearch is by far the most revealing method. On Wed, Aug 22, 2018 at 1:58 PM Ling Zou wrote: > Back to your original post, you mentioned that you played with NEWTONLS > while having DIVERGED_LINE_SEARCH error. > > You could play with other line search options such as 'basic'. > > I remember sometimes it helps. > > NEWTONLS could be combined with '-mat_mffd_type ds -mat_fd_type ds' > > > > http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/SNES/SNESLineSearchSetType.html > > > -Ling > > > SNESLineSearchSetType - mcs.anl.gov > > www.mcs.anl.gov > Options Database-snes_linesearch_type -basic, bt, l2, cp, nleqerr, > shell See Also SNESLineSearchCreate(), SNESLineSearchType, > SNESLineSearchSetFromOptions() . Level ... > > > ------------------------------ > *From:* petsc-users on behalf of Ling > Zou > *Sent:* Wednesday, August 22, 2018 11:46:02 AM > *To:* Ellen Price; Matthew Knepley; Smith, Barry F. > *Cc:* PETSc > *Subject:* Re: [petsc-users] Debugging SNES when "everything" looks okay > > > I think your Jacobian is good enough, otherwise you won't achieve one step > KSP convergence using '-pc_type lu'. > > Are you using matrix free? If so, could try: > > > '-mat_mffd_type ds -mat_fd_type ds' > > > -Ling > > > ------------------------------ > *From:* petsc-users on behalf of Ellen > Price > *Sent:* Wednesday, August 22, 2018 11:33:18 AM > *To:* Matthew Knepley; Smith, Barry F. > *Cc:* PETSc > *Subject:* Re: [petsc-users] Debugging SNES when "everything" looks okay > > For Barry: > > Okay, I'm stumped. Some of my Jacobian terms match up with the finite > difference one. Others are off by orders of magnitude. This led me to think > that maybe there was something wrong with my analytic Jacobian, so I went > back and started trying to track down which term causes the problem. The > weird thing is that Mathematica gives the same numerical result as my code > (within a small tolerance), whether i substitute numbers into its analytic > Jacobian or numerically differentiate the function I'm trying to solve > using Mathematica. I can't think of anything else to try for debugging the > Jacobian. Even if the function has a bug in it, Mathematica seems pretty > sure that I'm using the right Jacobian for what I put in... At the > suggestion of the FAQ, I also tried "-mat_fd_type ds" to see if that made > any difference, but it doesn't. Like I said, I'm stumped, but I'll keep > trying. > > For Matt: > > Using options "-pc_type lu -snes_view -snes_monitor -snes_converged_reason > -ksp_monitor_true_residual -ksp_converged_reason -snes_type newtontr", the > output is below. I thought that the step length convergence message had > something to do with using NEWTONTR, but I could be wrong about that. It > doesn't give that message when I switch to NEWTONLS. It also only gives > that message after the first iteration -- the first one is always > CONVERGED_RTOL. > > 7.533921e-03, 2.054699e+02 > 0 SNES Function norm 6.252612941119e+04 > 0 KSP preconditioned resid norm 1.027204021595e-01 true resid norm > 6.252612941119e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.641617517320e-17 true resid norm > 3.941610607093e-11 ||r(i)||/||b|| 6.303941478885e-16 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 1 SNES Function norm 6.252085930204e+04 > 0 KSP preconditioned resid norm 3.857372064539e-01 true resid norm > 6.252085930204e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.664921095158e-16 true resid norm > 2.434875289829e-10 ||r(i)||/||b|| 3.894500678672e-15 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 2 SNES Function norm 6.251886926050e+04 > 0 KSP preconditioned resid norm 4.085000006938e-01 true resid norm > 6.251886926050e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.318519617927e-16 true resid norm > 8.189931340015e-10 ||r(i)||/||b|| 1.309993516660e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > ..... > 48 SNES Function norm 6.229932776333e+04 > 0 KSP preconditioned resid norm 4.872526135345e+00 true resid norm > 6.229932776333e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.281571852581e-15 true resid norm > 8.562155918387e-09 ||r(i)||/||b|| 1.374357673796e-13 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 49 SNES Function norm 6.229663411026e+04 > 0 KSP preconditioned resid norm 4.953303401996e+00 true resid norm > 6.229663411026e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.537319689814e-15 true resid norm > 4.783442569088e-09 ||r(i)||/||b|| 7.678492806886e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 50 SNES Function norm 6.229442686875e+04 > Nonlinear solve did not converge due to DIVERGED_MAX_IT iterations 50 > SNES Object: 2 MPI processes > type: newtontr > Trust region tolerance (-snes_trtol) > mu=0.25, eta=0.75, sigma=0.0001 > delta0=0.2, delta1=0.3, delta2=0.75, delta3=2. > maximum iterations=50, maximum function evaluations=10000 > tolerances: relative=1e-08, absolute=1e-50, solution=1e-08 > total number of linear solver iterations=50 > total number of function evaluations=58 > norm schedule ALWAYS > SNESLineSearch Object: 2 MPI processes > type: basic > maxstep=1.000000e+08, minlambda=1.000000e-12 > tolerances: relative=1.000000e-08, absolute=1.000000e-15, > lambda=1.000000e-08 > maximum iterations=1 > KSP Object: 2 MPI processes > type: gmres > restart=30, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > happy breakdown tolerance 1e-30 > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: 2 MPI processes > type: lu > out-of-place factorization > tolerance for zero pivot 2.22045e-14 > matrix ordering: natural > factor fill ratio given 0., needed 0. > Factored matrix follows: > Mat Object: 2 MPI processes > type: mumps > rows=20, cols=20 > package used to perform factorization: mumps > total: nonzeros=112, allocated nonzeros=112 > total number of mallocs used during MatSetValues calls =0 > MUMPS run parameters: > SYM (matrix type): 0 > PAR (host participation): 1 > ICNTL(1) (output for error): 6 > ICNTL(2) (output of diagnostic msg): 0 > ICNTL(3) (output for global info): 0 > ICNTL(4) (level of printing): 0 > ICNTL(5) (input mat struct): 0 > ICNTL(6) (matrix prescaling): 7 > ICNTL(7) (sequential matrix ordering):7 > ICNTL(8) (scaling strategy): 77 > ICNTL(10) (max num of refinements): 0 > ICNTL(11) (error analysis): 0 > ICNTL(12) (efficiency control): 1 > ICNTL(13) (efficiency control): 0 > ICNTL(14) (percentage of estimated workspace increase): 20 > ICNTL(18) (input mat struct): 3 > ICNTL(19) (Schur complement info): 0 > ICNTL(20) (rhs sparse pattern): 0 > ICNTL(21) (solution struct): 1 > ICNTL(22) (in-core/out-of-core facility): 0 > ICNTL(23) (max size of memory can be allocated locally):0 > ICNTL(24) (detection of null pivot rows): 0 > ICNTL(25) (computation of a null space basis): 0 > ICNTL(26) (Schur options for rhs or solution): 0 > ICNTL(27) (experimental parameter): > -32 > ICNTL(28) (use parallel or sequential ordering): 1 > ICNTL(29) (parallel ordering): 0 > ICNTL(30) (user-specified set of entries in inv(A)): 0 > ICNTL(31) (factors is discarded in the solve phase): 0 > ICNTL(33) (compute determinant): 0 > ICNTL(35) (activate BLR based factorization): 0 > CNTL(1) (relative pivoting threshold): 0.01 > CNTL(2) (stopping criterion of refinement): 1.49012e-08 > CNTL(3) (absolute pivoting threshold): 0. > CNTL(4) (value of static pivoting): -1. > CNTL(5) (fixation for null pivots): 0. > CNTL(7) (dropping parameter for BLR): 0. > RINFO(1) (local estimated flops for the elimination after > analysis): > [0] 127. > [1] 155. > RINFO(2) (local estimated flops for the assembly after > factorization): > [0] 16. > [1] 16. > RINFO(3) (local estimated flops for the elimination after > factorization): > [0] 127. > [1] 155. > INFO(15) (estimated size of (in MB) MUMPS internal data > for running numerical factorization): > [0] 1 > [1] 1 > INFO(16) (size of (in MB) MUMPS internal data used during > numerical factorization): > [0] 1 > [1] 1 > INFO(23) (num of pivots eliminated on this processor after > factorization): > [0] 10 > [1] 10 > RINFOG(1) (global estimated flops for the elimination > after analysis): 282. > RINFOG(2) (global estimated flops for the assembly after > factorization): 32. > RINFOG(3) (global estimated flops for the elimination > after factorization): 282. > (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): > (0.,0.)*(2^0) > INFOG(3) (estimated real workspace for factors on all > processors after analysis): 112 > INFOG(4) (estimated integer workspace for factors on all > processors after analysis): 225 > INFOG(5) (estimated maximum front size in the complete > tree): 4 > INFOG(6) (number of nodes in the complete tree): 9 > INFOG(7) (ordering option effectively use after analysis): > 2 > INFOG(8) (structural symmetry in percent of the permuted > matrix after analysis): 100 > INFOG(9) (total real/complex workspace to store the matrix > factors after factorization): 112 > INFOG(10) (total integer space store the matrix factors > after factorization): 225 > INFOG(11) (order of largest frontal matrix after > factorization): 4 > INFOG(12) (number of off-diagonal pivots): 0 > INFOG(13) (number of delayed pivots after factorization): > 0 > INFOG(14) (number of memory compress after factorization): > 0 > INFOG(15) (number of steps of iterative refinement after > solution): 0 > INFOG(16) (estimated size (in MB) of all MUMPS internal > data for factorization after analysis: value on the most memory consuming > processor): 1 > INFOG(17) (estimated size of all MUMPS internal data for > factorization after analysis: sum over all processors): 2 > INFOG(18) (size of all MUMPS internal data allocated > during factorization: value on the most memory consuming processor): 1 > INFOG(19) (size of all MUMPS internal data allocated > during factorization: sum over all processors): 2 > INFOG(20) (estimated number of entries in the factors): > 112 > INFOG(21) (size in MB of memory effectively used during > factorization - value on the most memory consuming processor): 1 > INFOG(22) (size in MB of memory effectively used during > factorization - sum over all processors): 2 > INFOG(23) (after analysis: value of ICNTL(6) effectively > used): 0 > INFOG(24) (after analysis: value of ICNTL(12) effectively > used): 1 > INFOG(25) (after factorization: number of pivots modified > by static pivoting): 0 > INFOG(28) (after factorization: number of null pivots > encountered): 0 > INFOG(29) (after factorization: effective number of > entries in the factors (sum over all processors)): 112 > INFOG(30, 31) (after solution: size in Mbytes of memory > used during solution phase): 0, 0 > INFOG(32) (after analysis: type of analysis done): 1 > INFOG(33) (value used for ICNTL(8)): 7 > INFOG(34) (exponent of the determinant if determinant is > requested): 0 > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaij > rows=20, cols=20, bs=2 > total: nonzeros=112, allocated nonzeros=240 > total number of mallocs used during MatSetValues calls =0 > > Ellen > > On Tue, Aug 21, 2018 at 10:16 PM Matthew Knepley > wrote: > > On Tue, Aug 21, 2018 at 10:00 PM Ellen M. Price < > ellen.price at cfa.harvard.edu> wrote: > > Hi PETSc users, > > I'm having trouble applying SNES to a new problem I'm working on. I'll > try to be as complete as possible but can't post the full code because > it's ongoing research and is pretty long anyway. > > The nonlinear problem arises from trying to solve a set of two coupled > ODEs using a Galerkin method. I am using Mathematica to generate the > objective function to solve and the Jacobian, so I *think* I can rule > out human error on that front. > > There are four things I can easily change: > > - number of DMDA grid points N (I've tried 100 and 1000) > - preconditioner (I've tried LU and SVD, LU appears to work better, and > SVD is too slow for N = 1000) > - linear solver (haven't played with this much, but sometimes smaller > tolerances work better) > - nonlinear solver (what I'm having trouble with) > > Trying different solvers should, as far as I'm aware, give comparable > answers, but that's not the case here. NEWTONTR works best of the ones > I've tried, but I'm suspicious that the function value barely decreases > before SNES "converges" -- and none of the options I've tried changing > seem to affect this, as it just finds another reason to converge without > making any real progress. For example: > > 0 SNES Function norm 7.197788479418e+00 > 0 KSP Residual norm 1.721996766619e+01 > 1 KSP Residual norm 5.186021549059e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > > > This makes no sense. LU should converge due to atol or rtol. Send the > output of > > -snes_view -snes_monitor -snes_converged_reason > -ksp_monitor_true_residual -ksp_converged_reason > > Thanks, > > Matt > > > 1 SNES Function norm 7.197777674987e+00 > 0 KSP Residual norm 3.296112185897e+01 > 1 KSP Residual norm 2.713415432045e-13 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > ..... > 50 SNES Function norm 7.197376803542e+00 > 0 KSP Residual norm 6.222518656302e+02 > 1 KSP Residual norm 9.630659996504e-12 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 51 SNES Function norm 7.197376803542e+00 > Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 > > I've tried everything I can think of and the FAQ suggestions, including > non-dimensionalizing the problem; I observe the same behavior either > way. The particularly strange thing I can't understand is why some of > the SNES methods fail outright, after just one iteration (NCG, NGMRES, > and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems > like, for the most part, I should be able to substitute in one method > for another, possibly adjusting a few parameters along the way. > Furthermore, the default method, NEWTONLS, diverges with > DIVERGED_LINE_SEARCH, which I'm not sure how to debug. > > So the only viable method is NEWTONTR, and that doesn't appear to > "really" converge. Any suggestions for further things to try are > appreciated. My current options are: > > -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason > -snes_max_it 10000 -ksp_monitor -snes_type newtonls > > Thanks in advance, > Ellen Price > > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 22 13:36:46 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 22 Aug 2018 18:36:46 +0000 Subject: [petsc-users] Debugging SNES when "everything" looks okay In-Reply-To: References: Message-ID: Ellen, Perhaps it is not the Jacobian code that is wrong but your function evaluation code? This would explain why the PETSc finite difference result (which uses your function evaluation) would not match the analytic Jacobian. So recheck that the function evaluation code matches that produced by Mathematica. Barry > On Aug 22, 2018, at 12:33 PM, Ellen Price wrote: > > For Barry: > > Okay, I'm stumped. Some of my Jacobian terms match up with the finite difference one. Others are off by orders of magnitude. This led me to think that maybe there was something wrong with my analytic Jacobian, so I went back and started trying to track down which term causes the problem. The weird thing is that Mathematica gives the same numerical result as my code (within a small tolerance), whether i substitute numbers into its analytic Jacobian or numerically differentiate the function I'm trying to solve using Mathematica. I can't think of anything else to try for debugging the Jacobian. Even if the function has a bug in it, Mathematica seems pretty sure that I'm using the right Jacobian for what I put in... At the suggestion of the FAQ, I also tried "-mat_fd_type ds" to see if that made any difference, but it doesn't. Like I said, I'm stumped, but I'll keep trying. > > For Matt: > > Using options "-pc_type lu -snes_view -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason -snes_type newtontr", the output is below. I thought that the step length convergence message had something to do with using NEWTONTR, but I could be wrong about that. It doesn't give that message when I switch to NEWTONLS. It also only gives that message after the first iteration -- the first one is always CONVERGED_RTOL. > > 7.533921e-03, 2.054699e+02 > 0 SNES Function norm 6.252612941119e+04 > 0 KSP preconditioned resid norm 1.027204021595e-01 true resid norm 6.252612941119e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.641617517320e-17 true resid norm 3.941610607093e-11 ||r(i)||/||b|| 6.303941478885e-16 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 1 SNES Function norm 6.252085930204e+04 > 0 KSP preconditioned resid norm 3.857372064539e-01 true resid norm 6.252085930204e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.664921095158e-16 true resid norm 2.434875289829e-10 ||r(i)||/||b|| 3.894500678672e-15 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 2 SNES Function norm 6.251886926050e+04 > 0 KSP preconditioned resid norm 4.085000006938e-01 true resid norm 6.251886926050e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.318519617927e-16 true resid norm 8.189931340015e-10 ||r(i)||/||b|| 1.309993516660e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > ..... > 48 SNES Function norm 6.229932776333e+04 > 0 KSP preconditioned resid norm 4.872526135345e+00 true resid norm 6.229932776333e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.281571852581e-15 true resid norm 8.562155918387e-09 ||r(i)||/||b|| 1.374357673796e-13 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 49 SNES Function norm 6.229663411026e+04 > 0 KSP preconditioned resid norm 4.953303401996e+00 true resid norm 6.229663411026e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.537319689814e-15 true resid norm 4.783442569088e-09 ||r(i)||/||b|| 7.678492806886e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 50 SNES Function norm 6.229442686875e+04 > Nonlinear solve did not converge due to DIVERGED_MAX_IT iterations 50 > SNES Object: 2 MPI processes > type: newtontr > Trust region tolerance (-snes_trtol) > mu=0.25, eta=0.75, sigma=0.0001 > delta0=0.2, delta1=0.3, delta2=0.75, delta3=2. > maximum iterations=50, maximum function evaluations=10000 > tolerances: relative=1e-08, absolute=1e-50, solution=1e-08 > total number of linear solver iterations=50 > total number of function evaluations=58 > norm schedule ALWAYS > SNESLineSearch Object: 2 MPI processes > type: basic > maxstep=1.000000e+08, minlambda=1.000000e-12 > tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 > maximum iterations=1 > KSP Object: 2 MPI processes > type: gmres > restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > happy breakdown tolerance 1e-30 > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: 2 MPI processes > type: lu > out-of-place factorization > tolerance for zero pivot 2.22045e-14 > matrix ordering: natural > factor fill ratio given 0., needed 0. > Factored matrix follows: > Mat Object: 2 MPI processes > type: mumps > rows=20, cols=20 > package used to perform factorization: mumps > total: nonzeros=112, allocated nonzeros=112 > total number of mallocs used during MatSetValues calls =0 > MUMPS run parameters: > SYM (matrix type): 0 > PAR (host participation): 1 > ICNTL(1) (output for error): 6 > ICNTL(2) (output of diagnostic msg): 0 > ICNTL(3) (output for global info): 0 > ICNTL(4) (level of printing): 0 > ICNTL(5) (input mat struct): 0 > ICNTL(6) (matrix prescaling): 7 > ICNTL(7) (sequential matrix ordering):7 > ICNTL(8) (scaling strategy): 77 > ICNTL(10) (max num of refinements): 0 > ICNTL(11) (error analysis): 0 > ICNTL(12) (efficiency control): 1 > ICNTL(13) (efficiency control): 0 > ICNTL(14) (percentage of estimated workspace increase): 20 > ICNTL(18) (input mat struct): 3 > ICNTL(19) (Schur complement info): 0 > ICNTL(20) (rhs sparse pattern): 0 > ICNTL(21) (solution struct): 1 > ICNTL(22) (in-core/out-of-core facility): 0 > ICNTL(23) (max size of memory can be allocated locally):0 > ICNTL(24) (detection of null pivot rows): 0 > ICNTL(25) (computation of a null space basis): 0 > ICNTL(26) (Schur options for rhs or solution): 0 > ICNTL(27) (experimental parameter): -32 > ICNTL(28) (use parallel or sequential ordering): 1 > ICNTL(29) (parallel ordering): 0 > ICNTL(30) (user-specified set of entries in inv(A)): 0 > ICNTL(31) (factors is discarded in the solve phase): 0 > ICNTL(33) (compute determinant): 0 > ICNTL(35) (activate BLR based factorization): 0 > CNTL(1) (relative pivoting threshold): 0.01 > CNTL(2) (stopping criterion of refinement): 1.49012e-08 > CNTL(3) (absolute pivoting threshold): 0. > CNTL(4) (value of static pivoting): -1. > CNTL(5) (fixation for null pivots): 0. > CNTL(7) (dropping parameter for BLR): 0. > RINFO(1) (local estimated flops for the elimination after analysis): > [0] 127. > [1] 155. > RINFO(2) (local estimated flops for the assembly after factorization): > [0] 16. > [1] 16. > RINFO(3) (local estimated flops for the elimination after factorization): > [0] 127. > [1] 155. > INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): > [0] 1 > [1] 1 > INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): > [0] 1 > [1] 1 > INFO(23) (num of pivots eliminated on this processor after factorization): > [0] 10 > [1] 10 > RINFOG(1) (global estimated flops for the elimination after analysis): 282. > RINFOG(2) (global estimated flops for the assembly after factorization): 32. > RINFOG(3) (global estimated flops for the elimination after factorization): 282. > (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) > INFOG(3) (estimated real workspace for factors on all processors after analysis): 112 > INFOG(4) (estimated integer workspace for factors on all processors after analysis): 225 > INFOG(5) (estimated maximum front size in the complete tree): 4 > INFOG(6) (number of nodes in the complete tree): 9 > INFOG(7) (ordering option effectively use after analysis): 2 > INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 > INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 112 > INFOG(10) (total integer space store the matrix factors after factorization): 225 > INFOG(11) (order of largest frontal matrix after factorization): 4 > INFOG(12) (number of off-diagonal pivots): 0 > INFOG(13) (number of delayed pivots after factorization): 0 > INFOG(14) (number of memory compress after factorization): 0 > INFOG(15) (number of steps of iterative refinement after solution): 0 > INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 1 > INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 2 > INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 1 > INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 2 > INFOG(20) (estimated number of entries in the factors): 112 > INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 1 > INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 2 > INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 > INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 > INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 > INFOG(28) (after factorization: number of null pivots encountered): 0 > INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 112 > INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 0, 0 > INFOG(32) (after analysis: type of analysis done): 1 > INFOG(33) (value used for ICNTL(8)): 7 > INFOG(34) (exponent of the determinant if determinant is requested): 0 > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaij > rows=20, cols=20, bs=2 > total: nonzeros=112, allocated nonzeros=240 > total number of mallocs used during MatSetValues calls =0 > > Ellen > > On Tue, Aug 21, 2018 at 10:16 PM Matthew Knepley wrote: > On Tue, Aug 21, 2018 at 10:00 PM Ellen M. Price wrote: > Hi PETSc users, > > I'm having trouble applying SNES to a new problem I'm working on. I'll > try to be as complete as possible but can't post the full code because > it's ongoing research and is pretty long anyway. > > The nonlinear problem arises from trying to solve a set of two coupled > ODEs using a Galerkin method. I am using Mathematica to generate the > objective function to solve and the Jacobian, so I *think* I can rule > out human error on that front. > > There are four things I can easily change: > > - number of DMDA grid points N (I've tried 100 and 1000) > - preconditioner (I've tried LU and SVD, LU appears to work better, and > SVD is too slow for N = 1000) > - linear solver (haven't played with this much, but sometimes smaller > tolerances work better) > - nonlinear solver (what I'm having trouble with) > > Trying different solvers should, as far as I'm aware, give comparable > answers, but that's not the case here. NEWTONTR works best of the ones > I've tried, but I'm suspicious that the function value barely decreases > before SNES "converges" -- and none of the options I've tried changing > seem to affect this, as it just finds another reason to converge without > making any real progress. For example: > > 0 SNES Function norm 7.197788479418e+00 > 0 KSP Residual norm 1.721996766619e+01 > 1 KSP Residual norm 5.186021549059e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > > This makes no sense. LU should converge due to atol or rtol. Send the output of > > -snes_view -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason > > Thanks, > > Matt > > 1 SNES Function norm 7.197777674987e+00 > 0 KSP Residual norm 3.296112185897e+01 > 1 KSP Residual norm 2.713415432045e-13 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > ..... > 50 SNES Function norm 7.197376803542e+00 > 0 KSP Residual norm 6.222518656302e+02 > 1 KSP Residual norm 9.630659996504e-12 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 51 SNES Function norm 7.197376803542e+00 > Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 > > I've tried everything I can think of and the FAQ suggestions, including > non-dimensionalizing the problem; I observe the same behavior either > way. The particularly strange thing I can't understand is why some of > the SNES methods fail outright, after just one iteration (NCG, NGMRES, > and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems > like, for the most part, I should be able to substitute in one method > for another, possibly adjusting a few parameters along the way. > Furthermore, the default method, NEWTONLS, diverges with > DIVERGED_LINE_SEARCH, which I'm not sure how to debug. > > So the only viable method is NEWTONTR, and that doesn't appear to > "really" converge. Any suggestions for further things to try are > appreciated. My current options are: > > -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason > -snes_max_it 10000 -ksp_monitor -snes_type newtonls > > Thanks in advance, > Ellen Price > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ From knepley at gmail.com Wed Aug 22 13:50:12 2018 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 22 Aug 2018 14:50:12 -0400 Subject: [petsc-users] Debugging SNES when "everything" looks okay In-Reply-To: References: Message-ID: On Wed, Aug 22, 2018 at 1:33 PM Ellen Price wrote: > For Barry: > > Okay, I'm stumped. Some of my Jacobian terms match up with the finite > difference one. Others are off by orders of magnitude. This led me to think > that maybe there was something wrong with my analytic Jacobian, so I went > back and started trying to track down which term causes the problem. The > weird thing is that Mathematica gives the same numerical result as my code > (within a small tolerance), whether i substitute numbers into its analytic > Jacobian or numerically differentiate the function I'm trying to solve > using Mathematica. I can't think of anything else to try for debugging the > Jacobian. Even if the function has a bug in it, Mathematica seems pretty > sure that I'm using the right Jacobian for what I put in... At the > suggestion of the FAQ, I also tried "-mat_fd_type ds" to see if that made > any difference, but it doesn't. Like I said, I'm stumped, but I'll keep > trying. > > For Matt: > > Using options "-pc_type lu -snes_view -snes_monitor -snes_converged_reason > -ksp_monitor_true_residual -ksp_converged_reason -snes_type newtontr", the > output is below. I thought that the step length convergence message had > something to do with using NEWTONTR, but I could be wrong about that. It > doesn't give that message when I switch to NEWTONLS. It also only gives > that message after the first iteration -- the first one is always > CONVERGED_RTOL. > > 7.533921e-03, 2.054699e+02 > 0 SNES Function norm 6.252612941119e+04 > 0 KSP preconditioned resid norm 1.027204021595e-01 true resid norm > 6.252612941119e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.641617517320e-17 true resid norm > 3.941610607093e-11 ||r(i)||/||b|| 6.303941478885e-16 > Linear solve converged due to CONVERGED_RTOL iterations 1 > Shoot, I forgot to have you add -snes_linesearch_monitor, but what that would show is that you cut down the step scaling lambda until its 1e-10 or something, so nothing changes in your residual norm. This means your Jacobian does not match your function. > 1 SNES Function norm 6.252085930204e+04 > 0 KSP preconditioned resid norm 3.857372064539e-01 true resid norm > 6.252085930204e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.664921095158e-16 true resid norm > 2.434875289829e-10 ||r(i)||/||b|| 3.894500678672e-15 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > This is another indication that there is mismatch. Now the solution to your linear equation is almost 0, so Newton thinks you should not move at all. Matt > 2 SNES Function norm 6.251886926050e+04 > 0 KSP preconditioned resid norm 4.085000006938e-01 true resid norm > 6.251886926050e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.318519617927e-16 true resid norm > 8.189931340015e-10 ||r(i)||/||b|| 1.309993516660e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > ..... > 48 SNES Function norm 6.229932776333e+04 > 0 KSP preconditioned resid norm 4.872526135345e+00 true resid norm > 6.229932776333e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.281571852581e-15 true resid norm > 8.562155918387e-09 ||r(i)||/||b|| 1.374357673796e-13 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 49 SNES Function norm 6.229663411026e+04 > 0 KSP preconditioned resid norm 4.953303401996e+00 true resid norm > 6.229663411026e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.537319689814e-15 true resid norm > 4.783442569088e-09 ||r(i)||/||b|| 7.678492806886e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 50 SNES Function norm 6.229442686875e+04 > Nonlinear solve did not converge due to DIVERGED_MAX_IT iterations 50 > SNES Object: 2 MPI processes > type: newtontr > Trust region tolerance (-snes_trtol) > mu=0.25, eta=0.75, sigma=0.0001 > delta0=0.2, delta1=0.3, delta2=0.75, delta3=2. > maximum iterations=50, maximum function evaluations=10000 > tolerances: relative=1e-08, absolute=1e-50, solution=1e-08 > total number of linear solver iterations=50 > total number of function evaluations=58 > norm schedule ALWAYS > SNESLineSearch Object: 2 MPI processes > type: basic > maxstep=1.000000e+08, minlambda=1.000000e-12 > tolerances: relative=1.000000e-08, absolute=1.000000e-15, > lambda=1.000000e-08 > maximum iterations=1 > KSP Object: 2 MPI processes > type: gmres > restart=30, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > happy breakdown tolerance 1e-30 > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: 2 MPI processes > type: lu > out-of-place factorization > tolerance for zero pivot 2.22045e-14 > matrix ordering: natural > factor fill ratio given 0., needed 0. > Factored matrix follows: > Mat Object: 2 MPI processes > type: mumps > rows=20, cols=20 > package used to perform factorization: mumps > total: nonzeros=112, allocated nonzeros=112 > total number of mallocs used during MatSetValues calls =0 > MUMPS run parameters: > SYM (matrix type): 0 > PAR (host participation): 1 > ICNTL(1) (output for error): 6 > ICNTL(2) (output of diagnostic msg): 0 > ICNTL(3) (output for global info): 0 > ICNTL(4) (level of printing): 0 > ICNTL(5) (input mat struct): 0 > ICNTL(6) (matrix prescaling): 7 > ICNTL(7) (sequential matrix ordering):7 > ICNTL(8) (scaling strategy): 77 > ICNTL(10) (max num of refinements): 0 > ICNTL(11) (error analysis): 0 > ICNTL(12) (efficiency control): 1 > ICNTL(13) (efficiency control): 0 > ICNTL(14) (percentage of estimated workspace increase): 20 > ICNTL(18) (input mat struct): 3 > ICNTL(19) (Schur complement info): 0 > ICNTL(20) (rhs sparse pattern): 0 > ICNTL(21) (solution struct): 1 > ICNTL(22) (in-core/out-of-core facility): 0 > ICNTL(23) (max size of memory can be allocated locally):0 > ICNTL(24) (detection of null pivot rows): 0 > ICNTL(25) (computation of a null space basis): 0 > ICNTL(26) (Schur options for rhs or solution): 0 > ICNTL(27) (experimental parameter): > -32 > ICNTL(28) (use parallel or sequential ordering): 1 > ICNTL(29) (parallel ordering): 0 > ICNTL(30) (user-specified set of entries in inv(A)): 0 > ICNTL(31) (factors is discarded in the solve phase): 0 > ICNTL(33) (compute determinant): 0 > ICNTL(35) (activate BLR based factorization): 0 > CNTL(1) (relative pivoting threshold): 0.01 > CNTL(2) (stopping criterion of refinement): 1.49012e-08 > CNTL(3) (absolute pivoting threshold): 0. > CNTL(4) (value of static pivoting): -1. > CNTL(5) (fixation for null pivots): 0. > CNTL(7) (dropping parameter for BLR): 0. > RINFO(1) (local estimated flops for the elimination after > analysis): > [0] 127. > [1] 155. > RINFO(2) (local estimated flops for the assembly after > factorization): > [0] 16. > [1] 16. > RINFO(3) (local estimated flops for the elimination after > factorization): > [0] 127. > [1] 155. > INFO(15) (estimated size of (in MB) MUMPS internal data > for running numerical factorization): > [0] 1 > [1] 1 > INFO(16) (size of (in MB) MUMPS internal data used during > numerical factorization): > [0] 1 > [1] 1 > INFO(23) (num of pivots eliminated on this processor after > factorization): > [0] 10 > [1] 10 > RINFOG(1) (global estimated flops for the elimination > after analysis): 282. > RINFOG(2) (global estimated flops for the assembly after > factorization): 32. > RINFOG(3) (global estimated flops for the elimination > after factorization): 282. > (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): > (0.,0.)*(2^0) > INFOG(3) (estimated real workspace for factors on all > processors after analysis): 112 > INFOG(4) (estimated integer workspace for factors on all > processors after analysis): 225 > INFOG(5) (estimated maximum front size in the complete > tree): 4 > INFOG(6) (number of nodes in the complete tree): 9 > INFOG(7) (ordering option effectively use after analysis): > 2 > INFOG(8) (structural symmetry in percent of the permuted > matrix after analysis): 100 > INFOG(9) (total real/complex workspace to store the matrix > factors after factorization): 112 > INFOG(10) (total integer space store the matrix factors > after factorization): 225 > INFOG(11) (order of largest frontal matrix after > factorization): 4 > INFOG(12) (number of off-diagonal pivots): 0 > INFOG(13) (number of delayed pivots after factorization): > 0 > INFOG(14) (number of memory compress after factorization): > 0 > INFOG(15) (number of steps of iterative refinement after > solution): 0 > INFOG(16) (estimated size (in MB) of all MUMPS internal > data for factorization after analysis: value on the most memory consuming > processor): 1 > INFOG(17) (estimated size of all MUMPS internal data for > factorization after analysis: sum over all processors): 2 > INFOG(18) (size of all MUMPS internal data allocated > during factorization: value on the most memory consuming processor): 1 > INFOG(19) (size of all MUMPS internal data allocated > during factorization: sum over all processors): 2 > INFOG(20) (estimated number of entries in the factors): > 112 > INFOG(21) (size in MB of memory effectively used during > factorization - value on the most memory consuming processor): 1 > INFOG(22) (size in MB of memory effectively used during > factorization - sum over all processors): 2 > INFOG(23) (after analysis: value of ICNTL(6) effectively > used): 0 > INFOG(24) (after analysis: value of ICNTL(12) effectively > used): 1 > INFOG(25) (after factorization: number of pivots modified > by static pivoting): 0 > INFOG(28) (after factorization: number of null pivots > encountered): 0 > INFOG(29) (after factorization: effective number of > entries in the factors (sum over all processors)): 112 > INFOG(30, 31) (after solution: size in Mbytes of memory > used during solution phase): 0, 0 > INFOG(32) (after analysis: type of analysis done): 1 > INFOG(33) (value used for ICNTL(8)): 7 > INFOG(34) (exponent of the determinant if determinant is > requested): 0 > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaij > rows=20, cols=20, bs=2 > total: nonzeros=112, allocated nonzeros=240 > total number of mallocs used during MatSetValues calls =0 > > Ellen > > On Tue, Aug 21, 2018 at 10:16 PM Matthew Knepley > wrote: > >> On Tue, Aug 21, 2018 at 10:00 PM Ellen M. Price < >> ellen.price at cfa.harvard.edu> wrote: >> >>> Hi PETSc users, >>> >>> I'm having trouble applying SNES to a new problem I'm working on. I'll >>> try to be as complete as possible but can't post the full code because >>> it's ongoing research and is pretty long anyway. >>> >>> The nonlinear problem arises from trying to solve a set of two coupled >>> ODEs using a Galerkin method. I am using Mathematica to generate the >>> objective function to solve and the Jacobian, so I *think* I can rule >>> out human error on that front. >>> >>> There are four things I can easily change: >>> >>> - number of DMDA grid points N (I've tried 100 and 1000) >>> - preconditioner (I've tried LU and SVD, LU appears to work better, and >>> SVD is too slow for N = 1000) >>> - linear solver (haven't played with this much, but sometimes smaller >>> tolerances work better) >>> - nonlinear solver (what I'm having trouble with) >>> >>> Trying different solvers should, as far as I'm aware, give comparable >>> answers, but that's not the case here. NEWTONTR works best of the ones >>> I've tried, but I'm suspicious that the function value barely decreases >>> before SNES "converges" -- and none of the options I've tried changing >>> seem to affect this, as it just finds another reason to converge without >>> making any real progress. For example: >>> >>> 0 SNES Function norm 7.197788479418e+00 >>> 0 KSP Residual norm 1.721996766619e+01 >>> 1 KSP Residual norm 5.186021549059e-14 >>> Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 >>> >> >> This makes no sense. LU should converge due to atol or rtol. Send the >> output of >> >> -snes_view -snes_monitor -snes_converged_reason >> -ksp_monitor_true_residual -ksp_converged_reason >> >> Thanks, >> >> Matt >> >> >>> 1 SNES Function norm 7.197777674987e+00 >>> 0 KSP Residual norm 3.296112185897e+01 >>> 1 KSP Residual norm 2.713415432045e-13 >>> Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 >>> ..... >>> 50 SNES Function norm 7.197376803542e+00 >>> 0 KSP Residual norm 6.222518656302e+02 >>> 1 KSP Residual norm 9.630659996504e-12 >>> Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 >>> 51 SNES Function norm 7.197376803542e+00 >>> Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 >>> >>> I've tried everything I can think of and the FAQ suggestions, including >>> non-dimensionalizing the problem; I observe the same behavior either >>> way. The particularly strange thing I can't understand is why some of >>> the SNES methods fail outright, after just one iteration (NCG, NGMRES, >>> and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems >>> like, for the most part, I should be able to substitute in one method >>> for another, possibly adjusting a few parameters along the way. >>> Furthermore, the default method, NEWTONLS, diverges with >>> DIVERGED_LINE_SEARCH, which I'm not sure how to debug. >>> >>> So the only viable method is NEWTONTR, and that doesn't appear to >>> "really" converge. Any suggestions for further things to try are >>> appreciated. My current options are: >>> >>> -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason >>> -snes_max_it 10000 -ksp_monitor -snes_type newtonls >>> >>> Thanks in advance, >>> Ellen Price >>> >> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 22 13:55:16 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 22 Aug 2018 18:55:16 +0000 Subject: [petsc-users] Debugging SNES when "everything" looks okay In-Reply-To: References: Message-ID: <8E01C6E5-2802-4BA1-AF8F-9688DBD5158D@mcs.anl.gov> The values KSP_CONVERGED_CG_NEG_CURVE, KSP_CONVERGED_CG_CONSTRAINED, and KSP_CONVERGED_STEP_LENGTH are returned only by the special KSPCGNASH, KSPCGSTCG, and KSPCGGLTR solvers which are used by the SNESNEWTONTR (trust region) solver. Ellen, Stick to the newtonls SNES solver for now, it is easier to debug than the newtontr solver. Barry > On Aug 22, 2018, at 1:50 PM, Matthew Knepley wrote: > > On Wed, Aug 22, 2018 at 1:33 PM Ellen Price wrote: > For Barry: > > Okay, I'm stumped. Some of my Jacobian terms match up with the finite difference one. Others are off by orders of magnitude. This led me to think that maybe there was something wrong with my analytic Jacobian, so I went back and started trying to track down which term causes the problem. The weird thing is that Mathematica gives the same numerical result as my code (within a small tolerance), whether i substitute numbers into its analytic Jacobian or numerically differentiate the function I'm trying to solve using Mathematica. I can't think of anything else to try for debugging the Jacobian. Even if the function has a bug in it, Mathematica seems pretty sure that I'm using the right Jacobian for what I put in... At the suggestion of the FAQ, I also tried "-mat_fd_type ds" to see if that made any difference, but it doesn't. Like I said, I'm stumped, but I'll keep trying. > > For Matt: > > Using options "-pc_type lu -snes_view -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason -snes_type newtontr", the output is below. I thought that the step length convergence message had something to do with using NEWTONTR, but I could be wrong about that. It doesn't give that message when I switch to NEWTONLS. It also only gives that message after the first iteration -- the first one is always CONVERGED_RTOL. > > 7.533921e-03, 2.054699e+02 > 0 SNES Function norm 6.252612941119e+04 > 0 KSP preconditioned resid norm 1.027204021595e-01 true resid norm 6.252612941119e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.641617517320e-17 true resid norm 3.941610607093e-11 ||r(i)||/||b|| 6.303941478885e-16 > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Shoot, I forgot to have you add -snes_linesearch_monitor, but what that would show is that you cut down the step > scaling lambda until its 1e-10 or something, so nothing changes in your residual norm. This means your Jacobian > does not match your function. > > 1 SNES Function norm 6.252085930204e+04 > 0 KSP preconditioned resid norm 3.857372064539e-01 true resid norm 6.252085930204e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.664921095158e-16 true resid norm 2.434875289829e-10 ||r(i)||/||b|| 3.894500678672e-15 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > > This is another indication that there is mismatch. Now the solution to your linear equation is almost 0, so Newton thinks you > should not move at all. > > Matt > > 2 SNES Function norm 6.251886926050e+04 > 0 KSP preconditioned resid norm 4.085000006938e-01 true resid norm 6.251886926050e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.318519617927e-16 true resid norm 8.189931340015e-10 ||r(i)||/||b|| 1.309993516660e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > ..... > 48 SNES Function norm 6.229932776333e+04 > 0 KSP preconditioned resid norm 4.872526135345e+00 true resid norm 6.229932776333e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.281571852581e-15 true resid norm 8.562155918387e-09 ||r(i)||/||b|| 1.374357673796e-13 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 49 SNES Function norm 6.229663411026e+04 > 0 KSP preconditioned resid norm 4.953303401996e+00 true resid norm 6.229663411026e+04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.537319689814e-15 true resid norm 4.783442569088e-09 ||r(i)||/||b|| 7.678492806886e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 50 SNES Function norm 6.229442686875e+04 > Nonlinear solve did not converge due to DIVERGED_MAX_IT iterations 50 > SNES Object: 2 MPI processes > type: newtontr > Trust region tolerance (-snes_trtol) > mu=0.25, eta=0.75, sigma=0.0001 > delta0=0.2, delta1=0.3, delta2=0.75, delta3=2. > maximum iterations=50, maximum function evaluations=10000 > tolerances: relative=1e-08, absolute=1e-50, solution=1e-08 > total number of linear solver iterations=50 > total number of function evaluations=58 > norm schedule ALWAYS > SNESLineSearch Object: 2 MPI processes > type: basic > maxstep=1.000000e+08, minlambda=1.000000e-12 > tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 > maximum iterations=1 > KSP Object: 2 MPI processes > type: gmres > restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > happy breakdown tolerance 1e-30 > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: 2 MPI processes > type: lu > out-of-place factorization > tolerance for zero pivot 2.22045e-14 > matrix ordering: natural > factor fill ratio given 0., needed 0. > Factored matrix follows: > Mat Object: 2 MPI processes > type: mumps > rows=20, cols=20 > package used to perform factorization: mumps > total: nonzeros=112, allocated nonzeros=112 > total number of mallocs used during MatSetValues calls =0 > MUMPS run parameters: > SYM (matrix type): 0 > PAR (host participation): 1 > ICNTL(1) (output for error): 6 > ICNTL(2) (output of diagnostic msg): 0 > ICNTL(3) (output for global info): 0 > ICNTL(4) (level of printing): 0 > ICNTL(5) (input mat struct): 0 > ICNTL(6) (matrix prescaling): 7 > ICNTL(7) (sequential matrix ordering):7 > ICNTL(8) (scaling strategy): 77 > ICNTL(10) (max num of refinements): 0 > ICNTL(11) (error analysis): 0 > ICNTL(12) (efficiency control): 1 > ICNTL(13) (efficiency control): 0 > ICNTL(14) (percentage of estimated workspace increase): 20 > ICNTL(18) (input mat struct): 3 > ICNTL(19) (Schur complement info): 0 > ICNTL(20) (rhs sparse pattern): 0 > ICNTL(21) (solution struct): 1 > ICNTL(22) (in-core/out-of-core facility): 0 > ICNTL(23) (max size of memory can be allocated locally):0 > ICNTL(24) (detection of null pivot rows): 0 > ICNTL(25) (computation of a null space basis): 0 > ICNTL(26) (Schur options for rhs or solution): 0 > ICNTL(27) (experimental parameter): -32 > ICNTL(28) (use parallel or sequential ordering): 1 > ICNTL(29) (parallel ordering): 0 > ICNTL(30) (user-specified set of entries in inv(A)): 0 > ICNTL(31) (factors is discarded in the solve phase): 0 > ICNTL(33) (compute determinant): 0 > ICNTL(35) (activate BLR based factorization): 0 > CNTL(1) (relative pivoting threshold): 0.01 > CNTL(2) (stopping criterion of refinement): 1.49012e-08 > CNTL(3) (absolute pivoting threshold): 0. > CNTL(4) (value of static pivoting): -1. > CNTL(5) (fixation for null pivots): 0. > CNTL(7) (dropping parameter for BLR): 0. > RINFO(1) (local estimated flops for the elimination after analysis): > [0] 127. > [1] 155. > RINFO(2) (local estimated flops for the assembly after factorization): > [0] 16. > [1] 16. > RINFO(3) (local estimated flops for the elimination after factorization): > [0] 127. > [1] 155. > INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): > [0] 1 > [1] 1 > INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): > [0] 1 > [1] 1 > INFO(23) (num of pivots eliminated on this processor after factorization): > [0] 10 > [1] 10 > RINFOG(1) (global estimated flops for the elimination after analysis): 282. > RINFOG(2) (global estimated flops for the assembly after factorization): 32. > RINFOG(3) (global estimated flops for the elimination after factorization): 282. > (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) > INFOG(3) (estimated real workspace for factors on all processors after analysis): 112 > INFOG(4) (estimated integer workspace for factors on all processors after analysis): 225 > INFOG(5) (estimated maximum front size in the complete tree): 4 > INFOG(6) (number of nodes in the complete tree): 9 > INFOG(7) (ordering option effectively use after analysis): 2 > INFOG(8) (structural symmetry in percent of the permuted matrix after analysis): 100 > INFOG(9) (total real/complex workspace to store the matrix factors after factorization): 112 > INFOG(10) (total integer space store the matrix factors after factorization): 225 > INFOG(11) (order of largest frontal matrix after factorization): 4 > INFOG(12) (number of off-diagonal pivots): 0 > INFOG(13) (number of delayed pivots after factorization): 0 > INFOG(14) (number of memory compress after factorization): 0 > INFOG(15) (number of steps of iterative refinement after solution): 0 > INFOG(16) (estimated size (in MB) of all MUMPS internal data for factorization after analysis: value on the most memory consuming processor): 1 > INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 2 > INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 1 > INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 2 > INFOG(20) (estimated number of entries in the factors): 112 > INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 1 > INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 2 > INFOG(23) (after analysis: value of ICNTL(6) effectively used): 0 > INFOG(24) (after analysis: value of ICNTL(12) effectively used): 1 > INFOG(25) (after factorization: number of pivots modified by static pivoting): 0 > INFOG(28) (after factorization: number of null pivots encountered): 0 > INFOG(29) (after factorization: effective number of entries in the factors (sum over all processors)): 112 > INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 0, 0 > INFOG(32) (after analysis: type of analysis done): 1 > INFOG(33) (value used for ICNTL(8)): 7 > INFOG(34) (exponent of the determinant if determinant is requested): 0 > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaij > rows=20, cols=20, bs=2 > total: nonzeros=112, allocated nonzeros=240 > total number of mallocs used during MatSetValues calls =0 > > Ellen > > On Tue, Aug 21, 2018 at 10:16 PM Matthew Knepley wrote: > On Tue, Aug 21, 2018 at 10:00 PM Ellen M. Price wrote: > Hi PETSc users, > > I'm having trouble applying SNES to a new problem I'm working on. I'll > try to be as complete as possible but can't post the full code because > it's ongoing research and is pretty long anyway. > > The nonlinear problem arises from trying to solve a set of two coupled > ODEs using a Galerkin method. I am using Mathematica to generate the > objective function to solve and the Jacobian, so I *think* I can rule > out human error on that front. > > There are four things I can easily change: > > - number of DMDA grid points N (I've tried 100 and 1000) > - preconditioner (I've tried LU and SVD, LU appears to work better, and > SVD is too slow for N = 1000) > - linear solver (haven't played with this much, but sometimes smaller > tolerances work better) > - nonlinear solver (what I'm having trouble with) > > Trying different solvers should, as far as I'm aware, give comparable > answers, but that's not the case here. NEWTONTR works best of the ones > I've tried, but I'm suspicious that the function value barely decreases > before SNES "converges" -- and none of the options I've tried changing > seem to affect this, as it just finds another reason to converge without > making any real progress. For example: > > 0 SNES Function norm 7.197788479418e+00 > 0 KSP Residual norm 1.721996766619e+01 > 1 KSP Residual norm 5.186021549059e-14 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > > This makes no sense. LU should converge due to atol or rtol. Send the output of > > -snes_view -snes_monitor -snes_converged_reason -ksp_monitor_true_residual -ksp_converged_reason > > Thanks, > > Matt > > 1 SNES Function norm 7.197777674987e+00 > 0 KSP Residual norm 3.296112185897e+01 > 1 KSP Residual norm 2.713415432045e-13 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > ..... > 50 SNES Function norm 7.197376803542e+00 > 0 KSP Residual norm 6.222518656302e+02 > 1 KSP Residual norm 9.630659996504e-12 > Linear solve converged due to CONVERGED_STEP_LENGTH iterations 1 > 51 SNES Function norm 7.197376803542e+00 > Nonlinear solve converged due to CONVERGED_SNORM_RELATIVE iterations 50 > > I've tried everything I can think of and the FAQ suggestions, including > non-dimensionalizing the problem; I observe the same behavior either > way. The particularly strange thing I can't understand is why some of > the SNES methods fail outright, after just one iteration (NCG, NGMRES, > and others) with DIVERGED_DTOL. Unless I've misunderstood, it seems > like, for the most part, I should be able to substitute in one method > for another, possibly adjusting a few parameters along the way. > Furthermore, the default method, NEWTONLS, diverges with > DIVERGED_LINE_SEARCH, which I'm not sure how to debug. > > So the only viable method is NEWTONTR, and that doesn't appear to > "really" converge. Any suggestions for further things to try are > appreciated. My current options are: > > -pc_type lu -snes_monitor -snes_converged_reason -ksp_converged_reason > -snes_max_it 10000 -ksp_monitor -snes_type newtonls > > Thanks in advance, > Ellen Price > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ From dnpham at wpi.edu Thu Aug 23 10:41:07 2018 From: dnpham at wpi.edu (Pham, Dung Ngoc) Date: Thu, 23 Aug 2018 15:41:07 +0000 Subject: [petsc-users] V/v: Implementing checkpoints in matrix construction In-Reply-To: References: <9CBF6097-2A10-422E-AEF9-2BA0D44445C0@anl.gov>, Message-ID: Hello, My matrix is too large to be constructed in one node. The matrix construction is the issue here. My matrix is quite sparse with less 1% occupancy. If we preallocate the matrix and fill it with zero, won't it effect the sparsity? I suspect it may cause issues during eigenvalue analysis later. DP ________________________________ T??: Matthew Knepley ?a? g??i: 17 Tha?ng Ta?m 2018 4:16:09 CH ???n: Barry Smith Cc: Pham, Dung Ngoc; PETSc Ch? ??: Re: [petsc-users] Implementing checkpoints in matrix construction On Fri, Aug 17, 2018 at 4:02 PM Smith, Barry F. > wrote: I assume the matrix is relatively sparse? It is not even close to being amenable to this type of thing. I would simply have your program save the matrix entries to disk in some simple binary format and write another simple program that reads them in and sets them into a SeqAIJ matrix, It might be that his matrix is too large for the memory of one node. Is it? If so, you could use Jed's scheme for decomposing it. If that is not easy, you could do that following: 1) Preallocate the matrix 2) Fill it with zeros 3) Start calculating entries and adding them 4) At any time you can MatView() the matrix in binary format 5) You can always restart your calculations from the last MatView() just by MatLoad()ing that file Thanks, MAtt then VecView that matrix to a binary viewer, finally have your eigenvalue code simply use VecLoad to load the matrix and start the eigen computations. Barry > On Aug 17, 2018, at 2:45 PM, Pham, Dung Ngoc > wrote: > > Dear Petsc developers and Users, > > I am constructing a very large matrices (~5,000,000*5,000,000) for a generalized eigenvalue problem in MPIAIJ format across multiple nodes. The program is to be run on a shared HPC cluster using Slurm workload manager. Due to multiple loops and calculations needed, the matrix construction time is long (may span for more than a week). > > Hence, I am trying to see if I can implement checkpoints into the codes, so that the matrix can be constructed partially through multiple job submissions, each job picking up from where the previous one left until the matrix is fully built and we can write the global matrix into a binary file for further eigenvalue analysis. My questions are: > Does Petsc MPIAIJ format is amenable to such check points? > If so, are there any subroutines/functions that I can start with? > > I appreciate any comments/suggestions. > > Thank you, > D. N. Pham -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 23 11:33:27 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 23 Aug 2018 16:33:27 +0000 Subject: [petsc-users] V/v: Implementing checkpoints in matrix construction In-Reply-To: References: <9CBF6097-2A10-422E-AEF9-2BA0D44445C0@anl.gov> Message-ID: What is the nonzero structure of the matrix and how do you determine it? You must preallocate or the construction will take forever, perhaps that is why it takes so long you have not preallocated? Barry > On Aug 23, 2018, at 10:41 AM, Pham, Dung Ngoc wrote: > > Hello, > > My matrix is too large to be constructed in one node. The matrix construction is the issue here. My matrix is quite sparse with less 1% occupancy. If we preallocate the matrix and fill it with zero, won't it effect the sparsity? I suspect it may cause issues during eigenvalue analysis later. > > DP > > > T??: Matthew Knepley > ?a? g??i: 17 Tha?ng Ta?m 2018 4:16:09 CH > ???n: Barry Smith > Cc: Pham, Dung Ngoc; PETSc > Ch? ??: Re: [petsc-users] Implementing checkpoints in matrix construction > > On Fri, Aug 17, 2018 at 4:02 PM Smith, Barry F. wrote: > > I assume the matrix is relatively sparse? > > It is not even close to being amenable to this type of thing. > > I would simply have your program save the matrix entries to disk in some simple binary format and write another simple program that reads them in and sets them into a SeqAIJ matrix, > > It might be that his matrix is too large for the memory of one node. Is it? If so, you could use Jed's scheme for decomposing it. > If that is not easy, you could do that following: > > 1) Preallocate the matrix > > 2) Fill it with zeros > > 3) Start calculating entries and adding them > > 4) At any time you can MatView() the matrix in binary format > > 5) You can always restart your calculations from the last MatView() just by MatLoad()ing that file > > Thanks, > > MAtt > > then VecView that matrix to a binary viewer, finally have your eigenvalue code simply use VecLoad to load the matrix and start the eigen computations. > > Barry > > > > On Aug 17, 2018, at 2:45 PM, Pham, Dung Ngoc wrote: > > > > Dear Petsc developers and Users, > > > > I am constructing a very large matrices (~5,000,000*5,000,000) for a generalized eigenvalue problem in MPIAIJ format across multiple nodes. The program is to be run on a shared HPC cluster using Slurm workload manager. Due to multiple loops and calculations needed, the matrix construction time is long (may span for more than a week). > > > > Hence, I am trying to see if I can implement checkpoints into the codes, so that the matrix can be constructed partially through multiple job submissions, each job picking up from where the previous one left until the matrix is fully built and we can write the global matrix into a binary file for further eigenvalue analysis. My questions are: > > Does Petsc MPIAIJ format is amenable to such check points? > > If so, are there any subroutines/functions that I can start with? > > > > I appreciate any comments/suggestions. > > > > Thank you, > > D. N. Pham > > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ From bkallemov at lbl.gov Thu Aug 23 16:15:44 2018 From: bkallemov at lbl.gov (Bakytzhan Kallemov) Date: Thu, 23 Aug 2018 14:15:44 -0700 Subject: [petsc-users] error building petsc with gcc Message-ID: Hello, We are getting an error when linking our code. This is our compiler: kallemov at cori03:~/svn_treb/EBAMRINS/execBCG> CC --version g++ (GCC) 7.3.0 20180125 (Cray Inc.) Copyright (C) 2017 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. We are missing an external function __isnormal. Do you have any ideas? Baky (and Mark Adams) /bin/csh -f -c "CC -march=native -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs -Wno-literal-suffix -Wno-variadic-macros -fopenmp -O3 -march=native -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs -Wno-literal-suffix -Wno-variadic-macros -fopenmp o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/viscousDriver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCrankNicolson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/AMRINSUtils.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/CotanIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrigIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/ArteryIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairyIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCPPlotter.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RampIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycle.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscSolver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilter.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebDirichletPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscAMRSolver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowAdvectBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeCCProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyWithGhost.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelCCProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscLinearSolverPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebNeumannPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeMACProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelMACProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscCompGridPois.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowAdvectBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowPoissonDomainBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBCFactory.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebEBPetscLinearSolverPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyOver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/extrapolateData.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RobinPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/SVD.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowIBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowVortex.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/lsStencil.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/Choose.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/PoiseuilleInflowBCValue.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/util.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridConductivity.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscMap.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycleF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilterF.o -L../../../Chombo/lib -lebamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lworkshop3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lboxtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lbasetools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -L/opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib -lhdf5 -lz -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -Wl,-rpath,/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -lpetsc -lsuperlu_dist -lHYPRE -lparmetis -lmetis -lstdc++ -ldl -lgfortran -lm -lgomp -o viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex |& awk -f ../../../Chombo/lib/mk/tempnam.awk" /opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib/libhdf5.a(H5PL.o): In function `H5PL_load': H5PL.c:(.text+0x7a0): warning: Using 'dlopen' in statically linked applications requires at runtime the shared libraries from the glibc version used for linking /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(send.o): In function `PetscOpenSocket': /global/u2/m/madams/petsc_install/petsc/src/sys/classes/viewer/impls/socket/send.c:107: warning: Using 'gethostbyname' in statically linked applications requires at runtime the shared libraries from the glibc version used for linking /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(mathinf.o): In function `PetscIsNormalReal': /global/u2/m/madams/petsc_install/petsc/src/sys/utils/mathinf.c:23: undefined reference to `__isnormal' /usr/bin/ld: link errors found, deleting executable `viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' collect2: error: ld returned 1 exit status ../../../Chombo/lib/mk/Make.rules:412: recipe for target 'viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' failed gmake[1]: *** [viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex] Error 1 ../../../Chombo/lib/mk/Make.rules:325: recipe for target 'all-example' failed -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 23 16:23:38 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 23 Aug 2018 21:23:38 +0000 Subject: [petsc-users] error building petsc with gcc In-Reply-To: References: Message-ID: <8568A313-6AF9-44C8-9E5F-D4081F3F4895@anl.gov> Send configure.log and make.log to petsc-maint at mcs.anl.gov Barry > On Aug 23, 2018, at 4:15 PM, Bakytzhan Kallemov wrote: > > Hello, > > We are getting an error when linking our code. > This is our compiler: > > kallemov at cori03:~/svn_treb/EBAMRINS/execBCG> CC --version > g++ (GCC) 7.3.0 20180125 (Cray Inc.) > Copyright (C) 2017 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. > > We are missing an external function __isnormal. Do you have any ideas? > > Baky (and Mark Adams) > > > /bin/csh -f -c "CC -march=native -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs -Wno-literal-suffix -Wno-variadic-macros -fopenmp -O3 -march=native -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs -Wno-literal-suffix -Wno-variadic-macros -fopenmp o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/viscousDriver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCrankNicolson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/AMRINSUtils.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/CotanIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrigIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/ArteryIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairyIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCPPlotter.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RampIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycle.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscSolver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilter.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebDirichletPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscAMRSolver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowAdvectBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeCCProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyWithGhost.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelCCProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscLinearSolverPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebNeumannPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeMACProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelMACProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscCompGridPois.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowAdvectBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowPoissonDomainBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBCFactory.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebEBPetscLinearSolverPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyOver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/extrapolateData.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RobinPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/SVD.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowIBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowVortex.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/lsStencil.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/Choose.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/PoiseuilleInflowBCValue.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/util.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridConductivity.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscMap.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycleF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilterF.o -L../../../Chombo/lib -lebamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lworkshop3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lboxtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lbasetools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -L/opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib -lhdf5 -lz -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -Wl,-rpath,/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -lpetsc -lsuperlu_dist -lHYPRE -lparmetis -lmetis -lstdc++ -ldl -lgfortran -lm -lgomp -o viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex |& awk -f ../../../Chombo/lib/mk/tempnam.awk" > /opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib/libhdf5.a(H5PL.o): In function `H5PL_load': > H5PL.c:(.text+0x7a0): warning: Using 'dlopen' in statically linked applications requires at runtime the shared libraries from the glibc version used for linking > /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(send.o): In function `PetscOpenSocket': > /global/u2/m/madams/petsc_install/petsc/src/sys/classes/viewer/impls/socket/send.c:107: warning: Using 'gethostbyname' in statically linked applications requires at runtime the shared libraries from the glibc version used for linking > /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(mathinf.o): In function `PetscIsNormalReal': > /global/u2/m/madams/petsc_install/petsc/src/sys/utils/mathinf.c:23: undefined reference to `__isnormal' > /usr/bin/ld: link errors found, deleting executable `viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' > collect2: error: ld returned 1 exit status > ../../../Chombo/lib/mk/Make.rules:412: recipe for target 'viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' failed > gmake[1]: *** [viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex] Error 1 > ../../../Chombo/lib/mk/Make.rules:325: recipe for target 'all-example' failed > From mfadams at lbl.gov Thu Aug 23 16:36:04 2018 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 23 Aug 2018 14:36:04 -0700 Subject: [petsc-users] error building petsc with gcc In-Reply-To: <8568A313-6AF9-44C8-9E5F-D4081F3F4895@anl.gov> References: <8568A313-6AF9-44C8-9E5F-D4081F3F4895@anl.gov> Message-ID: This was an installed PETSc the logs have been clobbered, so I am reconfiguring now and will retest and send logs. Thanks, Mark On Thu, Aug 23, 2018 at 2:24 PM Smith, Barry F. wrote: > > Send configure.log and make.log to petsc-maint at mcs.anl.gov > > Barry > > > > On Aug 23, 2018, at 4:15 PM, Bakytzhan Kallemov > wrote: > > > > Hello, > > > > We are getting an error when linking our code. > > This is our compiler: > > > > kallemov at cori03:~/svn_treb/EBAMRINS/execBCG> CC --version > > g++ (GCC) 7.3.0 20180125 (Cray Inc.) > > Copyright (C) 2017 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. > > > > We are missing an external function __isnormal. Do you have any ideas? > > > > Baky (and Mark Adams) > > > > > > /bin/csh -f -c "CC -march=native -std=c++11 > -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare > -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs > -Wno-literal-suffix -Wno-variadic-macros -fopenmp -O3 -march=native > -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare > -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs > -Wno-literal-suffix -Wno-variadic-macros -fopenmp > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/viscousDriver.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCrankNicolson.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/AMRINSUtils.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/CotanIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrigIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/ArteryIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairyIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCPPlotter.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RampIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycle.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscSolver.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilter.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebDirichletPoissonEBBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscAMRSolver.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowAdvectBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeCCProjector.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyWithGhost.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelCCProjector.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscLinearSolverPoisson.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebNeumannPoissonEBBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeMACProjector.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelMACProjector.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscCompGridPois.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowAdvectBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowPoissonDomainBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBCFactory.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebEBPetscLinearSolverPoisson.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyOver.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/extrapolateData.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RobinPoissonEBBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/SVD.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowIBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowVortex.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/lsStencil.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/Choose.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/PoiseuilleInflowBCValue.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/util.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridConductivity.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscMap.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridPoisson.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycleF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilterF.o > -L../../../Chombo/lib > -lebamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC - > lebamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC - > lebamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lworkshop3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lebtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC - > lamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lboxtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lbasetools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -L/opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib -lhdf5 -lz > -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib > -Wl,-rpath,/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib > -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib > -lpetsc -lsuperlu_dist -lHYPRE -lparmetis -lmetis -lstdc++ -ldl > -lgfortran -lm -lgomp -o viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex > |& awk -f ../../../Chombo/lib/mk/tempnam.awk" > > /opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib/libhdf5.a(H5PL.o): In > function `H5PL_load': > > H5PL.c:(.text+0x7a0): warning: Using 'dlopen' in statically linked > applications requires at runtime the shared libraries from the glibc > version used for linking > > > /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(send.o): > In function `PetscOpenSocket': > > > /global/u2/m/madams/petsc_install/petsc/src/sys/classes/viewer/impls/socket/send.c:107: > warning: Using 'gethostbyname' in statically linked applications requires > at runtime the shared libraries from the glibc version used for linking > > > /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(mathinf.o): > In function `PetscIsNormalReal': > > /global/u2/m/madams/petsc_install/petsc/src/sys/utils/mathinf.c:23: > undefined reference to `__isnormal' > > /usr/bin/ld: link errors found, deleting executable ` > viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' > > collect2: error: ld returned 1 exit status > > ../../../Chombo/lib/mk/Make.rules:412: recipe for target ' > viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' failed > > gmake[1]: *** [viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex] > Error 1 > > ../../../Chombo/lib/mk/Make.rules:325: recipe for target 'all-example' > failed > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 23 21:23:27 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Fri, 24 Aug 2018 02:23:27 +0000 Subject: [petsc-users] error building petsc with gcc In-Reply-To: References: Message-ID: <923A6698-FD26-40E0-9671-2733FACB7169@anl.gov> Some mixup between an Intel build and a gcc build? > On Aug 23, 2018, at 4:15 PM, Bakytzhan Kallemov wrote: > > Hello, > > We are getting an error when linking our code. > This is our compiler: > > kallemov at cori03:~/svn_treb/EBAMRINS/execBCG> CC --version > g++ (GCC) 7.3.0 20180125 (Cray Inc.) > Copyright (C) 2017 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. > > We are missing an external function __isnormal. Do you have any ideas? > > Baky (and Mark Adams) > > > /bin/csh -f -c "CC -march=native -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs -Wno-literal-suffix -Wno-variadic-macros -fopenmp -O3 -march=native -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs -Wno-literal-suffix -Wno-variadic-macros -fopenmp o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/viscousDriver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCrankNicolson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/AMRINSUtils.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/CotanIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrigIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/ArteryIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairyIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCPPlotter.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RampIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycle.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscSolver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilter.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebDirichletPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscAMRSolver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowAdvectBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeCCProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyWithGhost.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelCCProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscLinearSolverPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebNeumannPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeMACProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelMACProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscCompGridPois.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowAdvectBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowPoissonDomainBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBCFactory.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebEBPetscLinearSolverPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyOver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/extrapolateData.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RobinPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/SVD.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowIBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowVortex.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/lsStencil.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/Choose.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/PoiseuilleInflowBCValue.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/util.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridConductivity.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscMap.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycleF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilterF.o -L../../../Chombo/lib -lebamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lworkshop3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lboxtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lbasetools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -L/opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib -lhdf5 -lz -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -Wl,-rpath,/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -lpetsc -lsuperlu_dist -lHYPRE -lparmetis -lmetis -lstdc++ -ldl -lgfortran -lm -lgomp -o viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex |& awk -f ../../../Chombo/lib/mk/tempnam.awk" > /opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib/libhdf5.a(H5PL.o): In function `H5PL_load': > H5PL.c:(.text+0x7a0): warning: Using 'dlopen' in statically linked applications requires at runtime the shared libraries from the glibc version used for linking > /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(send.o): In function `PetscOpenSocket': > /global/u2/m/madams/petsc_install/petsc/src/sys/classes/viewer/impls/socket/send.c:107: warning: Using 'gethostbyname' in statically linked applications requires at runtime the shared libraries from the glibc version used for linking > /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(mathinf.o): In function `PetscIsNormalReal': > /global/u2/m/madams/petsc_install/petsc/src/sys/utils/mathinf.c:23: undefined reference to `__isnormal' > /usr/bin/ld: link errors found, deleting executable `viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' > collect2: error: ld returned 1 exit status > ../../../Chombo/lib/mk/Make.rules:412: recipe for target 'viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' failed > gmake[1]: *** [viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex] Error 1 > ../../../Chombo/lib/mk/Make.rules:325: recipe for target 'all-example' failed > From mfadams at lbl.gov Fri Aug 24 00:32:49 2018 From: mfadams at lbl.gov (Mark Adams) Date: Thu, 23 Aug 2018 22:32:49 -0700 Subject: [petsc-users] error building petsc with gcc In-Reply-To: <923A6698-FD26-40E0-9671-2733FACB7169@anl.gov> References: <923A6698-FD26-40E0-9671-2733FACB7169@anl.gov> Message-ID: On Thu, Aug 23, 2018 at 7:23 PM Smith, Barry F. wrote: > > Some mixup between an Intel build and a gcc build? > I was careful about this. I reconfigured and am getting missing LAPACK methods on PETSc tests. (This __isnormal error came from building the application, which has its own build system and that might have LAPACK in it.) I reconfigured and download blas and PETSc tests are working. Baky: try it again. Thanks, Mark > > > > On Aug 23, 2018, at 4:15 PM, Bakytzhan Kallemov > wrote: > > > > Hello, > > > > We are getting an error when linking our code. > > This is our compiler: > > > > kallemov at cori03:~/svn_treb/EBAMRINS/execBCG> CC --version > > g++ (GCC) 7.3.0 20180125 (Cray Inc.) > > Copyright (C) 2017 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. > > > > We are missing an external function __isnormal. Do you have any ideas? > > > > Baky (and Mark Adams) > > > > > > /bin/csh -f -c "CC -march=native -std=c++11 > -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare > -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs > -Wno-literal-suffix -Wno-variadic-macros -fopenmp -O3 -march=native > -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare > -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs > -Wno-literal-suffix -Wno-variadic-macros -fopenmp > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/viscousDriver.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCrankNicolson.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/AMRINSUtils.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/CotanIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrigIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/ArteryIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairyIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCPPlotter.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RampIF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycle.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscSolver.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilter.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebDirichletPoissonEBBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscAMRSolver.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowAdvectBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeCCProjector.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyWithGhost.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelCCProjector.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscLinearSolverPoisson.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebNeumannPoissonEBBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeMACProjector.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelMACProjector.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscCompGridPois.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowAdvectBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowPoissonDomainBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBCFactory.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebEBPetscLinearSolverPoisson.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyOver.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/extrapolateData.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RobinPoissonEBBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/SVD.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowIBC.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowVortex.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/lsStencil.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/Choose.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/PoiseuilleInflowBCValue.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/util.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridConductivity.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscMap.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridPoisson.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycleF.o > o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilterF.o > -L../../../Chombo/lib > -lebamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC - > lebamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC - > lebamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lworkshop3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lebtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC - > lamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lboxtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -lbasetools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC > -L/opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib -lhdf5 -lz > -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib > -Wl,-rpath,/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib > -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib > -lpetsc -lsuperlu_dist -lHYPRE -lparmetis -lmetis -lstdc++ -ldl > -lgfortran -lm -lgomp -o viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex > |& awk -f ../../../Chombo/lib/mk/tempnam.awk" > > /opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib/libhdf5.a(H5PL.o): In > function `H5PL_load': > > H5PL.c:(.text+0x7a0): warning: Using 'dlopen' in statically linked > applications requires at runtime the shared libraries from the glibc > version used for linking > > > /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(send.o): > In function `PetscOpenSocket': > > > /global/u2/m/madams/petsc_install/petsc/src/sys/classes/viewer/impls/socket/send.c:107: > warning: Using 'gethostbyname' in statically linked applications requires > at runtime the shared libraries from the glibc version used for linking > > > /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(mathinf.o): > In function `PetscIsNormalReal': > > /global/u2/m/madams/petsc_install/petsc/src/sys/utils/mathinf.c:23: > undefined reference to `__isnormal' > > /usr/bin/ld: link errors found, deleting executable ` > viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' > > collect2: error: ld returned 1 exit status > > ../../../Chombo/lib/mk/Make.rules:412: recipe for target ' > viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' failed > > gmake[1]: *** [viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex] > Error 1 > > ../../../Chombo/lib/mk/Make.rules:325: recipe for target 'all-example' > failed > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From Savneet.KAUR at cea.fr Fri Aug 24 04:48:00 2018 From: Savneet.KAUR at cea.fr (Savneet Kaur) Date: Fri, 24 Aug 2018 11:48:00 +0200 Subject: [petsc-users] LINEAR SOLVER Message-ID: Hello, I am having a small trouble with PETSC. I am trying to use linear solver methods: LU and CHOLESKY but unable to run the code. The error message which I am getting is "See http://www.mcs.anl.gov/petsc/documentation/linearsolvertable.html for possible LU and Cholesky solvers [0]PETSC ERROR: Could not locate a solver package. Perhaps you must ./configure with --download- [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting." But while installing the PETSC, I am using this command line for the configuration *"./configure --with-cc=mpicc --with-fc=mpif90 --with-cxx=mpicxx --download-scalapack --download-mumps --download-hypre --download-parmetis --download-metis" .. *which should eventually install LU and cholesky packages as i am calling them to configure it using MUMPS package. And my second question would be, I want to install the non debug version of the PETSC and SLEPC. If you can help me in that? Infact, I even tried configruing with *"--with-debugging=0". *But it did not changed anything. Looking forward for your response. Thanks in advance. Regards, Savneet kaur ** -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Fri Aug 24 06:59:45 2018 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 24 Aug 2018 07:59:45 -0400 Subject: [petsc-users] LINEAR SOLVER In-Reply-To: References: Message-ID: On Fri, Aug 24, 2018 at 5:48 AM Savneet Kaur wrote: > Hello, > > I am having a small trouble with PETSC. > > I am trying to use linear solver methods: LU and CHOLESKY but unable to > run the code. The error message which I am getting is "See > http://www.mcs.anl.gov/petsc/documentation/linearsolvertable.html for > possible LU and Cholesky solvers > [0]PETSC ERROR: Could not locate a solver package. Perhaps you must > ./configure with --download- > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting." > > Please do not truncate the error message. Send all output. In order to use some other package, like MUMPS, you need *-pc_factor_mat_solver_type mumps* > But while installing the PETSC, I am using this command line for the > configuration *"./configure --with-cc=mpicc --with-fc=mpif90 > --with-cxx=mpicxx --download-scalapack --download-mumps --download-hypre > --download-parmetis --download-metis" .. *which should eventually install > LU and cholesky packages as i am calling them to configure it using MUMPS > package. > > > And my second question would be, I want to install the non debug version > of the PETSC and SLEPC. If you can help me in that? > > Infact, I even tried configruing with *"--with-debugging=0". *But it did > not changed anything. > > Perhaps you misspelled it. Please send configure.log for this build. Thanks, Matt > Looking forward for your response. > > > Thanks in advance. > > Regards, > > Savneet kaur > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Aug 24 11:43:11 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Fri, 24 Aug 2018 16:43:11 +0000 Subject: [petsc-users] error building petsc with gcc In-Reply-To: References: <923A6698-FD26-40E0-9671-2733FACB7169@anl.gov> Message-ID: <0BCBB268-EB38-4E27-98E3-A37015AB63B9@mcs.anl.gov> Is the application specifically linking against -lm and all the other libraries that PETSc links against? > On Aug 24, 2018, at 12:32 AM, Mark Adams wrote: > > > > On Thu, Aug 23, 2018 at 7:23 PM Smith, Barry F. wrote: > > Some mixup between an Intel build and a gcc build? > > I was careful about this. I reconfigured and am getting missing LAPACK methods on PETSc tests. (This __isnormal error came from building the application, which has its own build system and that might have LAPACK in it.) I reconfigured and download blas and PETSc tests are working. > > Baky: try it again. > > Thanks, > Mark > > > > > On Aug 23, 2018, at 4:15 PM, Bakytzhan Kallemov wrote: > > > > Hello, > > > > We are getting an error when linking our code. > > This is our compiler: > > > > kallemov at cori03:~/svn_treb/EBAMRINS/execBCG> CC --version > > g++ (GCC) 7.3.0 20180125 (Cray Inc.) > > Copyright (C) 2017 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. > > > > We are missing an external function __isnormal. Do you have any ideas? > > > > Baky (and Mark Adams) > > > > > > /bin/csh -f -c "CC -march=native -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs -Wno-literal-suffix -Wno-variadic-macros -fopenmp -O3 -march=native -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs -Wno-literal-suffix -Wno-variadic-macros -fopenmp o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/viscousDriver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCrankNicolson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/AMRINSUtils.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/CotanIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrigIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/ArteryIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairyIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCPPlotter.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RampIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycle.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscSolver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilter.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebDirichletPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscAMRSolver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowAdvectBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeCCProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyWithGhost.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelCCProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscLinearSolverPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebNeumannPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeMACProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelMACProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscCompGridPois.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowAdvectBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowPoissonDomainBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBCFactory.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebEBPetscLinearSolverPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyOver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/extrapolateData.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RobinPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/SVD.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowIBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowVortex.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/lsStencil.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/Choose.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/PoiseuilleInflowBCValue.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/util.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridConductivity.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscMap.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycleF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilterF.o -L../../../Chombo/lib -lebamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lworkshop3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lboxtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lbasetools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -L/opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib -lhdf5 -lz -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -Wl,-rpath,/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -lpetsc -lsuperlu_dist -lHYPRE -lparmetis -lmetis -lstdc++ -ldl -lgfortran -lm -lgomp -o viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex |& awk -f ../../../Chombo/lib/mk/tempnam.awk" > > /opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib/libhdf5.a(H5PL.o): In function `H5PL_load': > > H5PL.c:(.text+0x7a0): warning: Using 'dlopen' in statically linked applications requires at runtime the shared libraries from the glibc version used for linking > > /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(send.o): In function `PetscOpenSocket': > > /global/u2/m/madams/petsc_install/petsc/src/sys/classes/viewer/impls/socket/send.c:107: warning: Using 'gethostbyname' in statically linked applications requires at runtime the shared libraries from the glibc version used for linking > > /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(mathinf.o): In function `PetscIsNormalReal': > > /global/u2/m/madams/petsc_install/petsc/src/sys/utils/mathinf.c:23: undefined reference to `__isnormal' > > /usr/bin/ld: link errors found, deleting executable `viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' > > collect2: error: ld returned 1 exit status > > ../../../Chombo/lib/mk/Make.rules:412: recipe for target 'viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' failed > > gmake[1]: *** [viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex] Error 1 > > ../../../Chombo/lib/mk/Make.rules:325: recipe for target 'all-example' failed > > > From arkhazali at cc.iut.ac.ir Fri Aug 24 15:48:55 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Sat, 25 Aug 2018 01:18:55 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES Message-ID: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> Hi, I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. Below is a part of my code. It is run serially. Any help is much appreciated. ??? ierr = SNESGetKSP(snes, &Petsc_ksp); ??? CHKERRQ(ierr); ??? ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); ??? CHKERRQ(ierr); ??? ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); ??? CHKERRQ(ierr); ??? ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); ??? CHKERRQ(ierr); ??? ierr = SNESSetType(snes, SNESNEWTONLS); ??? CHKERRQ(ierr); ??? ierr = KSPSetType(Petsc_ksp, KSPGMRES); ??? CHKERRQ(ierr); ??? ierr = PCSetType(Petsc_pc, PCBJACOBI); ??? CHKERRQ(ierr); ??? ierr = PCSetType(Petsc_pc, PCBJACOBI); ??? CHKERRQ(ierr); ??? ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); ??? CHKERRQ(ierr); ??? SNESSetUp(snes); ??? CHKERRQ(ierr); ??? ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); ??? CHKERRQ(ierr); ??? for (i = 0; i < nLocal; i++) { ??? ??? ierr = KSPGetPC(subKSP[i], &SubPc); ??? ??? CHKERRQ(ierr); ??? ??? ierr = PCSetType(SubPc, PCLU); ??? ??? CHKERRQ(ierr); ??? ??? ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); ??? ??? CHKERRQ(ierr); ??? ??? ierr = KSPSetType(subKSP[i], KSPPREONLY); ??? ??? CHKERRQ(ierr); ??? ??? ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); ??? ??? CHKERRQ(ierr); ??? } ??? ierr = SNESSolve(snes, NULL, Petsc_X); ??? CHKERRQ(ierr); -- Ali Reza Khaz?ali Assistant Professor of Petroleum Engineering, Department of Chemical Engineering Isfahan University of Technology Isfahan, Iran From jed at jedbrown.org Fri Aug 24 17:32:14 2018 From: jed at jedbrown.org (Jed Brown) Date: Fri, 24 Aug 2018 16:32:14 -0600 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> Message-ID: <87zhxbz98x.fsf@jedbrown.org> Ali Reza Khaz'ali writes: > Hi, > > I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). > However, PCBJacobiGetSubKSP function returns an error stating "Object is > in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add > KSPSetUp, I got and error from them as: "Must call > DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if > PCSetUp is added, "Object is in wrong state, Matrix must be set first" > error is printed. We'd need the entire trace, but this is a run-time option -snes_rtol 1e-1 # Really? Then why solve KSP that much more accurately? -ksp_rtol 1e-3 -pc_type bjacobi -sub_pc_type lu -sub_pc_factor_mat_solver_type mkl_pardiso optionally setting the number of blocks (it's uncommon to not want the default) -pc_bjacobi_blocks N > Below is a part of my code. It is run serially. Any help is much > appreciated. > > ??? ierr = SNESGetKSP(snes, &Petsc_ksp); > ??? CHKERRQ(ierr); > ??? ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); > ??? CHKERRQ(ierr); > ??? ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); > ??? CHKERRQ(ierr); > ??? ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); > ??? CHKERRQ(ierr); > ??? ierr = SNESSetType(snes, SNESNEWTONLS); > ??? CHKERRQ(ierr); > ??? ierr = KSPSetType(Petsc_ksp, KSPGMRES); > ??? CHKERRQ(ierr); > ??? ierr = PCSetType(Petsc_pc, PCBJACOBI); > ??? CHKERRQ(ierr); > ??? ierr = PCSetType(Petsc_pc, PCBJACOBI); > ??? CHKERRQ(ierr); > ??? ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); > ??? CHKERRQ(ierr); > > ??? SNESSetUp(snes); > ??? CHKERRQ(ierr); > ??? ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); > ??? CHKERRQ(ierr); > > ??? for (i = 0; i < nLocal; i++) { > ??? ??? ierr = KSPGetPC(subKSP[i], &SubPc); > ??? ??? CHKERRQ(ierr); > ??? ??? ierr = PCSetType(SubPc, PCLU); > ??? ??? CHKERRQ(ierr); > ??? ??? ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); > ??? ??? CHKERRQ(ierr); > ??? ??? ierr = KSPSetType(subKSP[i], KSPPREONLY); > ??? ??? CHKERRQ(ierr); > ??? ??? ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, > PETSC_DEFAULT, PETSC_DEFAULT); > ??? ??? CHKERRQ(ierr); > ??? } > ??? ierr = SNESSolve(snes, NULL, Petsc_X); > ??? CHKERRQ(ierr); > > > > -- > Ali Reza Khaz?ali > Assistant Professor of Petroleum Engineering, > Department of Chemical Engineering > Isfahan University of Technology > Isfahan, Iran From bsmith at mcs.anl.gov Fri Aug 24 19:01:55 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Sat, 25 Aug 2018 00:01:55 +0000 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> Message-ID: <2C137976-24ED-4F18-B4C4-CC69D1666162@anl.gov> What you would like to do is reasonable but unfortunately the order of the operations in SNES/KSP means that the KSPSetUp() cannot be called before the SNESSolve() because the Jacobian matrix has yet to be provided to KSP. Thus you have to, as Jed suggested, use the options database to set the options. Note that if you want the options "hardwired" into the code you can use PetscOptionsSetValue() from the code. Barry > On Aug 24, 2018, at 1:48 PM, Ali Reza Khaz'ali wrote: > > Hi, > > I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. > > Below is a part of my code. It is run serially. Any help is much appreciated. > > ierr = SNESGetKSP(snes, &Petsc_ksp); > CHKERRQ(ierr); > ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); > CHKERRQ(ierr); > ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); > CHKERRQ(ierr); > ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); > CHKERRQ(ierr); > ierr = SNESSetType(snes, SNESNEWTONLS); > CHKERRQ(ierr); > ierr = KSPSetType(Petsc_ksp, KSPGMRES); > CHKERRQ(ierr); > ierr = PCSetType(Petsc_pc, PCBJACOBI); > CHKERRQ(ierr); > ierr = PCSetType(Petsc_pc, PCBJACOBI); > CHKERRQ(ierr); > ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); > CHKERRQ(ierr); > > SNESSetUp(snes); > CHKERRQ(ierr); > ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); > CHKERRQ(ierr); > > for (i = 0; i < nLocal; i++) { > ierr = KSPGetPC(subKSP[i], &SubPc); > CHKERRQ(ierr); > ierr = PCSetType(SubPc, PCLU); > CHKERRQ(ierr); > ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); > CHKERRQ(ierr); > ierr = KSPSetType(subKSP[i], KSPPREONLY); > CHKERRQ(ierr); > ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); > CHKERRQ(ierr); > } > ierr = SNESSolve(snes, NULL, Petsc_X); > CHKERRQ(ierr); > > > > -- > Ali Reza Khaz?ali > Assistant Professor of Petroleum Engineering, > Department of Chemical Engineering > Isfahan University of Technology > Isfahan, Iran > From mfadams at lbl.gov Sat Aug 25 11:34:23 2018 From: mfadams at lbl.gov (Mark Adams) Date: Sat, 25 Aug 2018 12:34:23 -0400 Subject: [petsc-users] error building petsc with gcc In-Reply-To: <0BCBB268-EB38-4E27-98E3-A37015AB63B9@mcs.anl.gov> References: <923A6698-FD26-40E0-9671-2733FACB7169@anl.gov> <0BCBB268-EB38-4E27-98E3-A37015AB63B9@mcs.anl.gov> Message-ID: On Fri, Aug 24, 2018 at 12:43 PM Smith, Barry F. wrote: > > Is the application specifically linking against -lm and all the other > libraries that PETSc links against? > > They have -lm and they use PETSC_LIBS (of some sort). They had: -lpetsc -lsuperlu_dist -lHYPRE -lparmetis -lmetis -lstdc++ -ldl -lgfortran -lm -lgomp Thanks, /bin/csh -f -c "CC -march=native -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs -Wno-literal-suffix -Wno-variadic-macros -fopenmp -O3 -march=native -std=c++11 -Wno-unused-but-set-variable -Wno-long-long -Wno-sign-compare -Wno-deprecated -ftemplate-depth-99 -Wno-unused-local-typedefs -Wno-literal-suffix -Wno-variadic-macros -fopenmp o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/viscousDriver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCrankNicolson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/AMRINSUtils.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/CotanIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrigIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/ArteryIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/HairyIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCPPlotter.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RampIF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycle.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscSolver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilter.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebDirichletPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscAMRSolver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowAdvectBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeCCProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyWithGhost.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelCCProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscLinearSolverPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebNeumannPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBCompositeMACProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBLevelMACProjector.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscCompGridPois.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowAdvectBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowPoissonDomainBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBIBCFactory.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/TrebEBPetscLinearSolverPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/copyOver.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/extrapolateData.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/RobinPoissonEBBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/SVD.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/InflowOutflowIBC.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/NoFlowVortex.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/lsStencil.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/Choose.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/PoiseuilleInflowBCValue.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/util.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridConductivity.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscMap.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBPetscGridPoisson.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBAMRNoSubcycleF.o o/3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC/EBGradDivFilterF.o -L../../../Chombo/lib -lebamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lworkshop3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lebtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrtimedependent3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrelliptic3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lamrtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lboxtools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -lbasetools3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC -L/opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib -lhdf5 -lz -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -Wl,-rpath,/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -L/global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib -lpetsc -lsuperlu_dist -lHYPRE -lparmetis -lmetis -lstdc++ -ldl -lgfortran -lm -lgomp -o viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex |& awk -f ../../../Chombo/lib/mk/tempnam.awk" /opt/cray/pe/hdf5-parallel/1.10.1.1/GNU/5.1/lib/libhdf5.a(H5PL.o): In function `H5PL_load': H5PL.c:(.text+0x7a0): warning: Using 'dlopen' in statically linked applications requires at runtime the shared libraries from the glibc version used for linking /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(send.o): In function `PetscOpenSocket': /global/u2/m/madams/petsc_install/petsc/src/sys/classes/viewer/impls/socket/send.c:107: warning: Using 'gethostbyname' in statically linked applications requires at runtime the shared libraries from the glibc version used for linking /global/homes/m/madams/petsc_install/petsc-cori-knl-opt64-gcc-omp/lib/libpetsc.a(mathinf.o): In function `PetscIsNormalReal': /global/u2/m/madams/petsc_install/petsc/src/sys/utils/mathinf.c:23: undefined reference to `__isnormal' /usr/bin/ld: link errors found, deleting executable `viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' collect2: error: ld returned 1 exit status ../../../Chombo/lib/mk/Make.rules:412: recipe for target 'viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex' failed gmake[1]: *** [viscousDriver3d.Linux.64.CC.ftn.OPTHIGH.MPI.OPENMPCC.PETSC.ex] Error 1 ../../../Chombo/lib/mk/Make.rules:325: recipe for target 'all-example' failed > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From arkhazali at cc.iut.ac.ir Sat Aug 25 13:30:14 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Sat, 25 Aug 2018 23:00:14 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <2C137976-24ED-4F18-B4C4-CC69D1666162@anl.gov> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <2C137976-24ED-4F18-B4C4-CC69D1666162@anl.gov> Message-ID: Dear Barry and Jed, Thanks for your great suggestions. I set the options as Jed proposed and it worked. However, Block Jacobi preconditioner treats the entire Jacobian matrix as only one giant block. It is good in small systems, but in larger ones, it requires a lot of memory and runtime, as direct methods do.? In addition, I cannot use -pc_bjacobi_blocks option, because the block sizes of the Jacobain matrix are variable (In my sample code, SadeqSize array contain block sizes), and apparently -pc_bjacobi_blocks option assumes the block sizes are equal. I have to add an explanation about unusual high tolerances in my code sample, in fact, I am facing a serious ill-conditioned problem. The direct methods (like LU) solve the system without problem, but I could not find any preconditioner+iterative solver that can solve it with the required precision.? Since direct solvers are useless in large systems, I had to design an specific preconditioner for it (I wrote a paper about it: https://link.springer.com/article/10.1007/s10596-014-9421-3), but the designed preconditioner was rather slow (even on GPU), and I hope that I can find a faster solution in PETSc. So for now I am searching for a combination that just works for me, and then, I'll refine it. Best wishes, Ali On 8/25/2018 4:31 AM, Smith, Barry F. wrote: > What you would like to do is reasonable but unfortunately the order of the operations in SNES/KSP means that the KSPSetUp() cannot be called before the SNESSolve() because the Jacobian matrix has yet to be provided to KSP. Thus you have to, as Jed suggested, use the options database to set the options. Note that if you want the options "hardwired" into the code you can use PetscOptionsSetValue() from the code. > > Barry > > >> On Aug 24, 2018, at 1:48 PM, Ali Reza Khaz'ali wrote: >> >> Hi, >> >> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >> >> Below is a part of my code. It is run serially. Any help is much appreciated. >> >> ierr = SNESGetKSP(snes, &Petsc_ksp); >> CHKERRQ(ierr); >> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >> CHKERRQ(ierr); >> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >> CHKERRQ(ierr); >> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >> CHKERRQ(ierr); >> ierr = SNESSetType(snes, SNESNEWTONLS); >> CHKERRQ(ierr); >> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >> CHKERRQ(ierr); >> ierr = PCSetType(Petsc_pc, PCBJACOBI); >> CHKERRQ(ierr); >> ierr = PCSetType(Petsc_pc, PCBJACOBI); >> CHKERRQ(ierr); >> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >> CHKERRQ(ierr); >> >> SNESSetUp(snes); >> CHKERRQ(ierr); >> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >> CHKERRQ(ierr); >> >> for (i = 0; i < nLocal; i++) { >> ierr = KSPGetPC(subKSP[i], &SubPc); >> CHKERRQ(ierr); >> ierr = PCSetType(SubPc, PCLU); >> CHKERRQ(ierr); >> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >> CHKERRQ(ierr); >> ierr = KSPSetType(subKSP[i], KSPPREONLY); >> CHKERRQ(ierr); >> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >> CHKERRQ(ierr); >> } >> ierr = SNESSolve(snes, NULL, Petsc_X); >> CHKERRQ(ierr); >> >> >> >> -- >> Ali Reza Khaz?ali >> Assistant Professor of Petroleum Engineering, >> Department of Chemical Engineering >> Isfahan University of Technology >> Isfahan, Iran >> From yjwu16 at gmail.com Sat Aug 25 20:54:25 2018 From: yjwu16 at gmail.com (Yingjie Wu) Date: Sun, 26 Aug 2018 09:54:25 +0800 Subject: [petsc-users] Question about I/O in PETSc Message-ID: Dear PETSc developer: Hello, I am a student of nuclear energy science from Tsinghua University. I want to do some work of neutron numerical simulation based on PETSc. At present, some examples of learning and testing PETSc have the following questions: 1. How to input data to PETSc conveniently? In some examples of VEC, PETSc support data input and output in .dat and HDF5 format. I don't know much about HDF5, and the binary data file I can't open with any software. I need an easy-to-view input and output format, preferably a file format that can be opened with a text editor for subsequent analysis and data loading. I'm not very good at using "petsc-users" mailing list. I'm very sorry if I disturb you. And I am looking forward to your reply. Thanks, Yingjie -------------- next part -------------- An HTML attachment was scrubbed... URL: From dave.mayhem23 at gmail.com Sun Aug 26 01:04:10 2018 From: dave.mayhem23 at gmail.com (Dave May) Date: Sun, 26 Aug 2018 08:04:10 +0200 Subject: [petsc-users] Question about I/O in PETSc In-Reply-To: References: Message-ID: On Sun, 26 Aug 2018 at 03:54, Yingjie Wu wrote: > Dear PETSc developer: > Hello, > I am a student of nuclear energy science from Tsinghua University. I want > to do some work of neutron numerical simulation based on PETSc. At present, > some examples of learning and testing PETSc have the following questions: > > 1. How to input data to PETSc conveniently? > What sort of data? Heavy data or stuff like model parameters / simulation params / meta data? For single values or relatively short arrays the methods PetscOptionsGetInt() and PetscOptionsGetIntArray() are useful. There are variants for real's, bool's and char's as well. See http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Sys/PetscOptionsGetInt.html Options can be parsed from the command line or collected in a text file which is parsed. In some examples of VEC, PETSc support data input and output in .dat and > HDF5 format. I don't know much about HDF5, and the binary data file I can't > open with any software. > You can use matlab See here https://www.mcs.anl.gov/petsc/documentation/faq.html#matlab I suggest following point b Thanks, Dave I need an easy-to-view input and output format, preferably a file format > that can be opened with a text editor for subsequent analysis and data > loading. > > I'm not very good at using "petsc-users" mailing list. I'm very sorry if I > disturb you. > And I am looking forward to your reply. > Thanks, > Yingjie > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Sun Aug 26 17:08:06 2018 From: jed at jedbrown.org (Jed Brown) Date: Sun, 26 Aug 2018 16:08:06 -0600 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <2C137976-24ED-4F18-B4C4-CC69D1666162@anl.gov> Message-ID: <87ftz0zsqh.fsf@jedbrown.org> Okay, interesting. I take it you either are not running in parallel or need to have several subdomains (of varying size) per process. One approach would be to use PCASM (with zero overlap, it is equivalent to Block Jacobi) and then use -mat_partitioning_type to select a partitioner (could be a general graph partitioner or could by a custom implementation that you provide). I don't know if this would feel overly clumsy or ultimately be a cleaner and more generic approach. Ali Reza Khaz'ali writes: > Dear Barry and Jed, > > Thanks for your great suggestions. I set the options as Jed proposed and > it worked. However, Block Jacobi preconditioner treats the entire > Jacobian matrix as only one giant block. It is good in small systems, > but in larger ones, it requires a lot of memory and runtime, as direct > methods do.? In addition, I cannot use -pc_bjacobi_blocks option, > because the block sizes of the Jacobain matrix are variable (In my > sample code, SadeqSize array contain block sizes), and apparently > -pc_bjacobi_blocks option assumes the block sizes are equal. > I have to add an explanation about unusual high tolerances in my code > sample, in fact, I am facing a serious ill-conditioned problem. The > direct methods (like LU) solve the system without problem, but I could > not find any preconditioner+iterative solver that can solve it with the > required precision.? Since direct solvers are useless in large systems, > I had to design an specific preconditioner for it (I wrote a paper about > it: https://link.springer.com/article/10.1007/s10596-014-9421-3), but > the designed preconditioner was rather slow (even on GPU), and I hope > that I can find a faster solution in PETSc. So for now I am searching > for a combination that just works for me, and then, I'll refine it. > > Best wishes, > Ali > > On 8/25/2018 4:31 AM, Smith, Barry F. wrote: >> What you would like to do is reasonable but unfortunately the order of the operations in SNES/KSP means that the KSPSetUp() cannot be called before the SNESSolve() because the Jacobian matrix has yet to be provided to KSP. Thus you have to, as Jed suggested, use the options database to set the options. Note that if you want the options "hardwired" into the code you can use PetscOptionsSetValue() from the code. >> >> Barry >> >> >>> On Aug 24, 2018, at 1:48 PM, Ali Reza Khaz'ali wrote: >>> >>> Hi, >>> >>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>> >>> Below is a part of my code. It is run serially. Any help is much appreciated. >>> >>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>> CHKERRQ(ierr); >>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>> CHKERRQ(ierr); >>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>> CHKERRQ(ierr); >>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>> CHKERRQ(ierr); >>> ierr = SNESSetType(snes, SNESNEWTONLS); >>> CHKERRQ(ierr); >>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>> CHKERRQ(ierr); >>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>> CHKERRQ(ierr); >>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>> CHKERRQ(ierr); >>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>> CHKERRQ(ierr); >>> >>> SNESSetUp(snes); >>> CHKERRQ(ierr); >>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>> CHKERRQ(ierr); >>> >>> for (i = 0; i < nLocal; i++) { >>> ierr = KSPGetPC(subKSP[i], &SubPc); >>> CHKERRQ(ierr); >>> ierr = PCSetType(SubPc, PCLU); >>> CHKERRQ(ierr); >>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>> CHKERRQ(ierr); >>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>> CHKERRQ(ierr); >>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>> CHKERRQ(ierr); >>> } >>> ierr = SNESSolve(snes, NULL, Petsc_X); >>> CHKERRQ(ierr); >>> >>> >>> >>> -- >>> Ali Reza Khaz?ali >>> Assistant Professor of Petroleum Engineering, >>> Department of Chemical Engineering >>> Isfahan University of Technology >>> Isfahan, Iran >>> From knepley at gmail.com Sun Aug 26 22:33:37 2018 From: knepley at gmail.com (Matthew Knepley) Date: Sun, 26 Aug 2018 23:33:37 -0400 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <2C137976-24ED-4F18-B4C4-CC69D1666162@anl.gov> Message-ID: On Sat, Aug 25, 2018 at 2:30 PM Ali Reza Khaz'ali wrote: > Dear Barry and Jed, > > Thanks for your great suggestions. I set the options as Jed proposed and > it worked. However, Block Jacobi preconditioner treats the entire > Jacobian matrix as only one giant block. It is good in small systems, > but in larger ones, it requires a lot of memory and runtime, as direct > methods do. In addition, I cannot use -pc_bjacobi_blocks option, > because the block sizes of the Jacobain matrix are variable (In my > sample code, SadeqSize array contain block sizes), and apparently > -pc_bjacobi_blocks option assumes the block sizes are equal. > I have to add an explanation about unusual high tolerances in my code > sample, in fact, I am facing a serious ill-conditioned problem. The > direct methods (like LU) solve the system without problem, but I could > not find any preconditioner+iterative solver that can solve it with the > required precision. Since direct solvers are useless in large systems, > Lets discuss this point a bit further. I assume your system is sparse. Sparse direct solvers can solve systems fairly efficiently for hundreds of thousands of unknowns. How big do you want? Also, do you plan on having more than 500K unknowns per process? If not, why not just use sparse direct solvers on each process? Thanks, Matt I had to design an specific preconditioner for it (I wrote a paper about > it: https://link.springer.com/article/10.1007/s10596-014-9421-3), but > the designed preconditioner was rather slow (even on GPU), and I hope > that I can find a faster solution in PETSc. So for now I am searching > for a combination that just works for me, and then, I'll refine it. > > Best wishes, > Ali > > On 8/25/2018 4:31 AM, Smith, Barry F. wrote: > > What you would like to do is reasonable but unfortunately the order > of the operations in SNES/KSP means that the KSPSetUp() cannot be called > before the SNESSolve() because the Jacobian matrix has yet to be provided > to KSP. Thus you have to, as Jed suggested, use the options database to set > the options. Note that if you want the options "hardwired" into the code > you can use PetscOptionsSetValue() from the code. > > > > Barry > > > > > >> On Aug 24, 2018, at 1:48 PM, Ali Reza Khaz'ali > wrote: > >> > >> Hi, > >> > >> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). > However, PCBJacobiGetSubKSP function returns an error stating "Object is in > wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, > I got and error from them as: "Must call DMShellSetGlobalVector() or > DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in > wrong state, Matrix must be set first" error is printed. > >> > >> Below is a part of my code. It is run serially. Any help is much > appreciated. > >> > >> ierr = SNESGetKSP(snes, &Petsc_ksp); > >> CHKERRQ(ierr); > >> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); > >> CHKERRQ(ierr); > >> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, > 20000); > >> CHKERRQ(ierr); > >> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); > >> CHKERRQ(ierr); > >> ierr = SNESSetType(snes, SNESNEWTONLS); > >> CHKERRQ(ierr); > >> ierr = KSPSetType(Petsc_ksp, KSPGMRES); > >> CHKERRQ(ierr); > >> ierr = PCSetType(Petsc_pc, PCBJACOBI); > >> CHKERRQ(ierr); > >> ierr = PCSetType(Petsc_pc, PCBJACOBI); > >> CHKERRQ(ierr); > >> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); > >> CHKERRQ(ierr); > >> > >> SNESSetUp(snes); > >> CHKERRQ(ierr); > >> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); > >> CHKERRQ(ierr); > >> > >> for (i = 0; i < nLocal; i++) { > >> ierr = KSPGetPC(subKSP[i], &SubPc); > >> CHKERRQ(ierr); > >> ierr = PCSetType(SubPc, PCLU); > >> CHKERRQ(ierr); > >> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); > >> CHKERRQ(ierr); > >> ierr = KSPSetType(subKSP[i], KSPPREONLY); > >> CHKERRQ(ierr); > >> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, > PETSC_DEFAULT, PETSC_DEFAULT); > >> CHKERRQ(ierr); > >> } > >> ierr = SNESSolve(snes, NULL, Petsc_X); > >> CHKERRQ(ierr); > >> > >> > >> > >> -- > >> Ali Reza Khaz?ali > >> Assistant Professor of Petroleum Engineering, > >> Department of Chemical Engineering > >> Isfahan University of Technology > >> Isfahan, Iran > >> > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From dave.mayhem23 at gmail.com Mon Aug 27 01:20:52 2018 From: dave.mayhem23 at gmail.com (Dave May) Date: Mon, 27 Aug 2018 08:20:52 +0200 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <2C137976-24ED-4F18-B4C4-CC69D1666162@anl.gov> Message-ID: If none of the suggestions provided is to your taste, why not just build the preconditioner matrix yourself? Seems your have precise requirements and the relevant info of the individual blocks, so you should be able to construct the preconditioner, either using A (original operator) or directly from the discrete problem. On Mon, 27 Aug 2018 at 05:33, Matthew Knepley wrote: > On Sat, Aug 25, 2018 at 2:30 PM Ali Reza Khaz'ali > wrote: > >> Dear Barry and Jed, >> >> Thanks for your great suggestions. I set the options as Jed proposed and >> it worked. However, Block Jacobi preconditioner treats the entire >> Jacobian matrix as only one giant block. It is good in small systems, >> but in larger ones, it requires a lot of memory and runtime, as direct >> methods do. In addition, I cannot use -pc_bjacobi_blocks option, >> because the block sizes of the Jacobain matrix are variable (In my >> sample code, SadeqSize array contain block sizes), and apparently >> -pc_bjacobi_blocks option assumes the block sizes are equal. >> I have to add an explanation about unusual high tolerances in my code >> sample, in fact, I am facing a serious ill-conditioned problem. The >> direct methods (like LU) solve the system without problem, but I could >> not find any preconditioner+iterative solver that can solve it with the >> required precision. Since direct solvers are useless in large systems, >> > > Lets discuss this point a bit further. I assume your system is sparse. > Sparse > direct solvers can solve systems fairly efficiently for hundreds of > thousands of > unknowns. How big do you want? Also, do you plan on having more than 500K > unknowns per process? If not, why not just use sparse direct solvers on > each process? > > Thanks, > > Matt > > I had to design an specific preconditioner for it (I wrote a paper about >> it: https://link.springer.com/article/10.1007/s10596-014-9421-3), but >> the designed preconditioner was rather slow (even on GPU), and I hope >> that I can find a faster solution in PETSc. So for now I am searching >> for a combination that just works for me, and then, I'll refine it. >> >> Best wishes, >> Ali >> >> On 8/25/2018 4:31 AM, Smith, Barry F. wrote: >> > What you would like to do is reasonable but unfortunately the order >> of the operations in SNES/KSP means that the KSPSetUp() cannot be called >> before the SNESSolve() because the Jacobian matrix has yet to be provided >> to KSP. Thus you have to, as Jed suggested, use the options database to set >> the options. Note that if you want the options "hardwired" into the code >> you can use PetscOptionsSetValue() from the code. >> > >> > Barry >> > >> > >> >> On Aug 24, 2018, at 1:48 PM, Ali Reza Khaz'ali >> wrote: >> >> >> >> Hi, >> >> >> >> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). >> However, PCBJacobiGetSubKSP function returns an error stating "Object is in >> wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, >> I got and error from them as: "Must call DMShellSetGlobalVector() or >> DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in >> wrong state, Matrix must be set first" error is printed. >> >> >> >> Below is a part of my code. It is run serially. Any help is much >> appreciated. >> >> >> >> ierr = SNESGetKSP(snes, &Petsc_ksp); >> >> CHKERRQ(ierr); >> >> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >> >> CHKERRQ(ierr); >> >> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, >> 20000); >> >> CHKERRQ(ierr); >> >> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >> >> CHKERRQ(ierr); >> >> ierr = SNESSetType(snes, SNESNEWTONLS); >> >> CHKERRQ(ierr); >> >> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >> >> CHKERRQ(ierr); >> >> ierr = PCSetType(Petsc_pc, PCBJACOBI); >> >> CHKERRQ(ierr); >> >> ierr = PCSetType(Petsc_pc, PCBJACOBI); >> >> CHKERRQ(ierr); >> >> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >> >> CHKERRQ(ierr); >> >> >> >> SNESSetUp(snes); >> >> CHKERRQ(ierr); >> >> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >> >> CHKERRQ(ierr); >> >> >> >> for (i = 0; i < nLocal; i++) { >> >> ierr = KSPGetPC(subKSP[i], &SubPc); >> >> CHKERRQ(ierr); >> >> ierr = PCSetType(SubPc, PCLU); >> >> CHKERRQ(ierr); >> >> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >> >> CHKERRQ(ierr); >> >> ierr = KSPSetType(subKSP[i], KSPPREONLY); >> >> CHKERRQ(ierr); >> >> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, >> PETSC_DEFAULT, PETSC_DEFAULT); >> >> CHKERRQ(ierr); >> >> } >> >> ierr = SNESSolve(snes, NULL, Petsc_X); >> >> CHKERRQ(ierr); >> >> >> >> >> >> >> >> -- >> >> Ali Reza Khaz?ali >> >> Assistant Professor of Petroleum Engineering, >> >> Department of Chemical Engineering >> >> Isfahan University of Technology >> >> Isfahan, Iran >> >> >> > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From arkhazali at cc.iut.ac.ir Mon Aug 27 03:12:36 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Mon, 27 Aug 2018 12:42:36 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES Message-ID: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> > Okay, interesting.? I take it you either are not running in parallel or need to have several subdomains (of varying size) per process. > One approach would be to use PCASM (with zero overlap, it is equivalent to Block Jacobi) and then use -mat_partitioning_type to select a partitioner (could be a general graph partitioner or could by a custom implementation that you provide).? I don't know if this would feel overly clumsy or ultimately be a cleaner and more generic approach. Thanks for the answer. I'm still running a serial code. I plan to parallelized it after finding a suitable solver. Unfortunately, I do not know how to use PCASM, and therefore, I'm going to learn it. In addition, I found another possible solution with MATNEST. However, I do not know if MATNEST is suitable for my application or if it can be used with SNES. I'd be grateful if you could kindly guide me about it. > Lets discuss this point a bit further. I assume your system is sparse. Sparse direct solvers can solve systems fairly efficiently for hundreds of thousands of unknowns. How big do you want? Also, do you plan on having more than 500K unknowns per process? If not, why not just use sparse direct solvers on each process? Thanks for the answer. My system is sparse, and also a variable sized block matrix. For example, for a small size simulation, I have about 7K unknowns. For ONE TIME STEP, Intel MKL PARDISO took about 30 minutes to solve my system, while occupying about 2.5GB out of my 4GB RAM. Since I have to simulate at least 10000 time steps, the runtime (and the required RAM) would be unacceptable. > If none of the suggestions provided is to your taste, why not just build the preconditioner matrix yourself? Seems your have precise requirements and the relevant info of the individual blocks, so you should be able to construct the preconditioner, either using A (original operator) or directly from the discrete problem. Thanks for your answer. As I stated, I have built a preconditioner for it. My preconditioner does not require a large memory, however, it has a low performance (even on GPU). Therefore, I'm trying to use PETSc functions and modules to solve the system more efficiently. I do not think there is any other library more suited than PETSc for the job. Best Regards, Ali From dave.mayhem23 at gmail.com Mon Aug 27 03:37:13 2018 From: dave.mayhem23 at gmail.com (Dave May) Date: Mon, 27 Aug 2018 10:37:13 +0200 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> Message-ID: On Mon, 27 Aug 2018 at 10:12, Ali Reza Khaz'ali wrote: > > Okay, interesting. I take it you either are not running in parallel > or need to have several subdomains (of varying size) per process. > > One approach would be to use PCASM (with zero overlap, it is > equivalent to Block Jacobi) and then use -mat_partitioning_type to > select a partitioner (could be a general graph partitioner or could by a > custom implementation that you provide). I don't know if this would > feel overly clumsy or ultimately be a cleaner and more generic approach. > > Thanks for the answer. I'm still running a serial code. I plan to > parallelized it after finding a suitable solver. Unfortunately, I do not > know how to use PCASM, and therefore, I'm going to learn it. In > addition, I found another possible solution with MATNEST. However, I do > not know if MATNEST is suitable for my application or if it can be used > with SNES. I'd be grateful if you could kindly guide me about it. > > > > > Lets discuss this point a bit further. I assume your system is > sparse. Sparse direct solvers can solve systems fairly efficiently for > hundreds of thousands of unknowns. How big do you want? Also, do you > plan on having more than 500K unknowns per process? If not, why not just > use sparse direct solvers on each process? > > Thanks for the answer. My system is sparse, and also a variable sized > block matrix. For example, for a small size simulation, I have about 7K > unknowns. For ONE TIME STEP, Intel MKL PARDISO took about 30 minutes to > solve my system, while occupying about 2.5GB out of my 4GB RAM. Since I > have to simulate at least 10000 time steps, the runtime (and the > required RAM) would be unacceptable. > > > > > If none of the suggestions provided is to your taste, why not just > build the preconditioner matrix yourself? Seems your have precise > requirements and the relevant info of the individual blocks, so you > should be able to construct the preconditioner, either using A (original > operator) or directly from the discrete problem. > > Thanks for your answer. As I stated, I have built a preconditioner for > it. I mean directly build the preconditioner with the required block diagonal structure. Then do don't need to use something like PCBJACOBI or PCASM to extract the block diagonal operator from your original operator. My preconditioner does not require a large memory, however, it has a > low performance (even on GPU). Therefore, I'm trying to use PETSc > functions and modules to solve the system more efficiently. I do not > think there is any other library more suited than PETSc for the job. > > > > Best Regards, > Ali > -------------- next part -------------- An HTML attachment was scrubbed... URL: From arkhazali at cc.iut.ac.ir Mon Aug 27 04:14:07 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Mon, 27 Aug 2018 13:44:07 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> Message-ID: <688c9045-50db-8b14-d484-ab25f050a0ed@cc.iut.ac.ir> > > I mean directly build the preconditioner with the required block > diagonal structure. Then do don't need to use something like PCBJACOBI > or PCASM to extract the block diagonal operator from your original > operator. > I know the block structure. I saved the block sizes in SadeqSize array, and I was trying to tell PCBJACOBI to use it: ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); Which based on previous communications, it seems to be incompatible with SNES, and PCBJacobiSetTotalBlocks function returned an error. -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Aug 27 07:50:27 2018 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 27 Aug 2018 08:50:27 -0400 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> Message-ID: On Mon, Aug 27, 2018 at 4:12 AM Ali Reza Khaz'ali wrote: > > Okay, interesting. I take it you either are not running in parallel > or need to have several subdomains (of varying size) per process. > > One approach would be to use PCASM (with zero overlap, it is > equivalent to Block Jacobi) and then use -mat_partitioning_type to > select a partitioner (could be a general graph partitioner or could by a > custom implementation that you provide). I don't know if this would > feel overly clumsy or ultimately be a cleaner and more generic approach. > > Thanks for the answer. I'm still running a serial code. I plan to > parallelized it after finding a suitable solver. Unfortunately, I do not > know how to use PCASM, and therefore, I'm going to learn it. In > addition, I found another possible solution with MATNEST. However, I do > not know if MATNEST is suitable for my application or if it can be used > with SNES. I'd be grateful if you could kindly guide me about it. > MATNEST is only a storage optimization after everything works right. It does not have to do with solving. > > Lets discuss this point a bit further. I assume your system is > sparse. Sparse direct solvers can solve systems fairly efficiently for > hundreds of thousands of unknowns. How big do you want? Also, do you > plan on having more than 500K unknowns per process? If not, why not just > use sparse direct solvers on each process? > > Thanks for the answer. My system is sparse, and also a variable sized > block matrix. For example, for a small size simulation, I have about 7K > unknowns. For ONE TIME STEP, Intel MKL PARDISO took about 30 minutes to > solve my system, while occupying about 2.5GB out of my 4GB RAM. Since I > have to simulate at least 10000 time steps, the runtime (and the > required RAM) would be unacceptable. > Something is very wrong there. I advise you to also try SuperLU and MUMPS. > > If none of the suggestions provided is to your taste, why not just > build the preconditioner matrix yourself? Seems your have precise > requirements and the relevant info of the individual blocks, so you > should be able to construct the preconditioner, either using A (original > operator) or directly from the discrete problem. > > Thanks for your answer. As I stated, I have built a preconditioner for > it. My preconditioner does not require a large memory, however, it has a > low performance (even on GPU). Therefore, I'm trying to use PETSc > functions and modules to solve the system more efficiently. I do not > think there is any other library more suited than PETSc for the job. > Iterative methods depend sensitively on the equation, as opposed to direct solvers which almost do not care. The first step in designing an iterative solver that PETSc can implement is to find in the literature where one has worked for your problem. Matt > Best Regards, > Ali > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From arkhazali at cc.iut.ac.ir Mon Aug 27 13:46:23 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Mon, 27 Aug 2018 23:16:23 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> Message-ID: <2d3ad8e0-b20b-44e1-fb49-ea92b80355ea@cc.iut.ac.ir> > MATNEST is only a storage optimization after everything works right. > It does > not have to do with solving. Thanks for the answer. I hoped that I could use block solvers suited for MATNEST, which apparently work for a variable-sized block matrix. To the extend of my knowledge, MatCreateBAIJ only accepts constant block sizes. > > Something is very wrong there. I advise you to also try SuperLU and MUMPS. I will try to compile them on windows, and report the result here. > Iterative methods depend sensitively on the equation, as opposed to direct > solvers which almost do not care. The first step in designing an > iterative solver > that PETSc can implement is to find in the literature where one has > worked for > your problem. What I'm trying to solve here, has never been studied before (compositional fractured petroleum reservoir simulation+coupled phase equilibrium formulation+diffusion mass transfer), therefore I can not seek help from the literature. Best wishes, Ali -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Aug 27 13:58:55 2018 From: jed at jedbrown.org (Jed Brown) Date: Mon, 27 Aug 2018 12:58:55 -0600 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <2d3ad8e0-b20b-44e1-fb49-ea92b80355ea@cc.iut.ac.ir> References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> <2d3ad8e0-b20b-44e1-fb49-ea92b80355ea@cc.iut.ac.ir> Message-ID: <87h8jfy6ts.fsf@jedbrown.org> Ali Reza Khaz'ali writes: >> MATNEST is only a storage optimization after everything works right. >> It does >> not have to do with solving. > Thanks for the answer. I hoped that I could use block solvers suited for > MATNEST, which apparently work for a variable-sized block matrix. To the > extend of my knowledge, MatCreateBAIJ only accepts constant block sizes. The BAIJ blocks are usually grouping of fields for each discretization "point". NEST is usually grouping different fields with which you want to use different sparse solution strategies (e.g., algebraic multigrid on some, a simpler solver on others). From stefano.zampini at gmail.com Mon Aug 27 14:24:00 2018 From: stefano.zampini at gmail.com (Stefano Zampini) Date: Mon, 27 Aug 2018 22:24:00 +0300 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> Message-ID: <41D4163E-FC5B-499A-B24D-A848DA5AA5C2@gmail.com> > Thanks for the answer. My system is sparse, and also a variable sized block matrix. For example, for a small size simulation, I have about 7K unknowns. For ONE TIME STEP, Intel MKL PARDISO took about 30 minutes to solve my system, while occupying about 2.5GB out of my 4GB RAM. Since I have to simulate at least 10000 time steps, the runtime (and the required RAM) would be unacceptable. > > This is very odd. A sparse linear system of 7K unknowns needs less than a second to be factored. If it is dense, seconds. How many nonzero per rows do you have? Is 7 thousand the typical size of your blocks in bjacobi? From arkhazali at cc.iut.ac.ir Mon Aug 27 14:31:05 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Tue, 28 Aug 2018 00:01:05 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <87h8jfy6ts.fsf@jedbrown.org> References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> <2d3ad8e0-b20b-44e1-fb49-ea92b80355ea@cc.iut.ac.ir> <87h8jfy6ts.fsf@jedbrown.org> Message-ID: <7351eb87-6d24-c9f7-6a4f-f7810fbf1e45@cc.iut.ac.ir> > The BAIJ blocks are usually grouping of fields for each discretization > "point". NEST is usually grouping different fields with which you want > to use different sparse solution strategies (e.g., algebraic multigrid > on some, a simpler solver on others). > I have to apologize for taking so much of your time. I'd be grateful if you could kindly answer my (hopefully last) question: what do you propose for a non-linear system that has variable number of unknowns in each of its discretization points? Many thanks, Ali From arkhazali at cc.iut.ac.ir Mon Aug 27 14:36:31 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Tue, 28 Aug 2018 00:06:31 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <41D4163E-FC5B-499A-B24D-A848DA5AA5C2@gmail.com> References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> <41D4163E-FC5B-499A-B24D-A848DA5AA5C2@gmail.com> Message-ID: <99f22ea5-e60e-8060-0a88-c1af5c6213e4@cc.iut.ac.ir> > This is very odd. A sparse linear system of 7K unknowns needs less than a second to be factored. If it is dense, seconds. > How many nonzero per rows do you have? > Is 7 thousand the typical size of your blocks in bjacobi? > > There are less than 100 non-zeros per row. 7K was the total size of Jacobian matrix. The block sizes of Jacobian are in range of 4-10. I could not inform bjacobi about the block sizes (see the communication about it please), so it treats the entire Jacobian matrix as one giant block. From jed at jedbrown.org Mon Aug 27 14:36:57 2018 From: jed at jedbrown.org (Jed Brown) Date: Mon, 27 Aug 2018 13:36:57 -0600 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <7351eb87-6d24-c9f7-6a4f-f7810fbf1e45@cc.iut.ac.ir> References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> <2d3ad8e0-b20b-44e1-fb49-ea92b80355ea@cc.iut.ac.ir> <87h8jfy6ts.fsf@jedbrown.org> <7351eb87-6d24-c9f7-6a4f-f7810fbf1e45@cc.iut.ac.ir> Message-ID: <87efejy52e.fsf@jedbrown.org> Ali Reza Khaz'ali writes: >> The BAIJ blocks are usually grouping of fields for each discretization >> "point". NEST is usually grouping different fields with which you want >> to use different sparse solution strategies (e.g., algebraic multigrid >> on some, a simpler solver on others). >> > I have to apologize for taking so much of your time. I'd be grateful if > you could kindly answer my (hopefully last) question: what do you > propose for a non-linear system that has variable number of unknowns in > each of its discretization points? Normal AIJ. From jed at jedbrown.org Mon Aug 27 14:38:29 2018 From: jed at jedbrown.org (Jed Brown) Date: Mon, 27 Aug 2018 13:38:29 -0600 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <99f22ea5-e60e-8060-0a88-c1af5c6213e4@cc.iut.ac.ir> References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> <41D4163E-FC5B-499A-B24D-A848DA5AA5C2@gmail.com> <99f22ea5-e60e-8060-0a88-c1af5c6213e4@cc.iut.ac.ir> Message-ID: <87bm9ny4zu.fsf@jedbrown.org> Ali Reza Khaz'ali writes: >> This is very odd. A sparse linear system of 7K unknowns needs less than a second to be factored. If it is dense, seconds. >> How many nonzero per rows do you have? >> Is 7 thousand the typical size of your blocks in bjacobi? >> >> > > There are less than 100 non-zeros per row. 7K was the total size of > Jacobian matrix. The block sizes of Jacobian are in range of 4-10. I > could not inform bjacobi about the block sizes (see the communication > about it please), so it treats the entire Jacobian matrix as one giant > block. This should take on the order of a second to solve with a sparse direct solver. What shape is your domain? Can you send a solver profile and output from running with -snes_view -log_view? From bsmith at mcs.anl.gov Mon Aug 27 16:01:24 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Mon, 27 Aug 2018 21:01:24 +0000 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> Message-ID: <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c Please let us know if it works for you and if you have any questions or problems. Barry Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. Sorry for the runaround with so many emails. > On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: > > Hi, > > I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. > > Below is a part of my code. It is run serially. Any help is much appreciated. > > ierr = SNESGetKSP(snes, &Petsc_ksp); > CHKERRQ(ierr); > ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); > CHKERRQ(ierr); > ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); > CHKERRQ(ierr); > ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); > CHKERRQ(ierr); > ierr = SNESSetType(snes, SNESNEWTONLS); > CHKERRQ(ierr); > ierr = KSPSetType(Petsc_ksp, KSPGMRES); > CHKERRQ(ierr); > ierr = PCSetType(Petsc_pc, PCBJACOBI); > CHKERRQ(ierr); > ierr = PCSetType(Petsc_pc, PCBJACOBI); > CHKERRQ(ierr); > ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); > CHKERRQ(ierr); > > SNESSetUp(snes); > CHKERRQ(ierr); > ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); > CHKERRQ(ierr); > > for (i = 0; i < nLocal; i++) { > ierr = KSPGetPC(subKSP[i], &SubPc); > CHKERRQ(ierr); > ierr = PCSetType(SubPc, PCLU); > CHKERRQ(ierr); > ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); > CHKERRQ(ierr); > ierr = KSPSetType(subKSP[i], KSPPREONLY); > CHKERRQ(ierr); > ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); > CHKERRQ(ierr); > } > ierr = SNESSolve(snes, NULL, Petsc_X); > CHKERRQ(ierr); > > > > -- > Ali Reza Khaz?ali > Assistant Professor of Petroleum Engineering, > Department of Chemical Engineering > Isfahan University of Technology > Isfahan, Iran > From jed at jedbrown.org Mon Aug 27 16:04:49 2018 From: jed at jedbrown.org (Jed Brown) Date: Mon, 27 Aug 2018 15:04:49 -0600 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> Message-ID: <871saj1pxq.fsf@jedbrown.org> "Smith, Barry F." writes: > I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c Note that this example is block Jacobi with O(1) sparse blocks per process, not variable-sized point-block Jacobi which I think is what Ali had in mind. > Please let us know if it works for you and if you have any questions or problems. > > Barry > > Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. > > Sorry for the runaround with so many emails. > > >> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >> >> Hi, >> >> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >> >> Below is a part of my code. It is run serially. Any help is much appreciated. >> >> ierr = SNESGetKSP(snes, &Petsc_ksp); >> CHKERRQ(ierr); >> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >> CHKERRQ(ierr); >> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >> CHKERRQ(ierr); >> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >> CHKERRQ(ierr); >> ierr = SNESSetType(snes, SNESNEWTONLS); >> CHKERRQ(ierr); >> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >> CHKERRQ(ierr); >> ierr = PCSetType(Petsc_pc, PCBJACOBI); >> CHKERRQ(ierr); >> ierr = PCSetType(Petsc_pc, PCBJACOBI); >> CHKERRQ(ierr); >> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >> CHKERRQ(ierr); >> >> SNESSetUp(snes); >> CHKERRQ(ierr); >> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >> CHKERRQ(ierr); >> >> for (i = 0; i < nLocal; i++) { >> ierr = KSPGetPC(subKSP[i], &SubPc); >> CHKERRQ(ierr); >> ierr = PCSetType(SubPc, PCLU); >> CHKERRQ(ierr); >> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >> CHKERRQ(ierr); >> ierr = KSPSetType(subKSP[i], KSPPREONLY); >> CHKERRQ(ierr); >> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >> CHKERRQ(ierr); >> } >> ierr = SNESSolve(snes, NULL, Petsc_X); >> CHKERRQ(ierr); >> >> >> >> -- >> Ali Reza Khaz?ali >> Assistant Professor of Petroleum Engineering, >> Department of Chemical Engineering >> Isfahan University of Technology >> Isfahan, Iran >> From arkhazali at cc.iut.ac.ir Mon Aug 27 16:04:59 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Tue, 28 Aug 2018 01:34:59 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <87bm9ny4zu.fsf@jedbrown.org> References: <5fc48168-72e8-c3c0-f071-362a7019ae65@cc.iut.ac.ir> <41D4163E-FC5B-499A-B24D-A848DA5AA5C2@gmail.com> <99f22ea5-e60e-8060-0a88-c1af5c6213e4@cc.iut.ac.ir> <87bm9ny4zu.fsf@jedbrown.org> Message-ID: > Normal AIJ. Can I use block preconditioners (like block ILU or Block Jacobi) with this matrix format? (for a matrix having variable sized blocks, of course) > This should take on the order of a second to solve with a sparse direct > solver. What shape is your domain? Can you send a solver profile and > output from running with -snes_view -log_view? > I have to admit that I made a mistake. The runtime and memeroy usage is what I reported if block Jacobi preconditioer with MKL PARDISO sub-preconditioer and GMRes solver is used. I apologize. If only PARDISO is utilized to solve the system with KSPPREONLY, the runtime is much better, but memory usage is still high. The following log is for a 30x30x10 cubic system and 3 hydrocarbon components (108000 unknowns total): ? type: newtonls ? maximum iterations=2000, maximum function evaluations=2000 ? tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 ? total number of linear solver iterations=1 ? total number of function evaluations=2 ? norm schedule ALWAYS ? SNESLineSearch Object: 1 MPI processes ??? type: bt ????? interpolation: cubic ????? alpha=1.000000e-04 ??? maxstep=1.000000e+08, minlambda=1.000000e-12 ??? tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 ??? maximum iterations=40 ? KSP Object: 1 MPI processes ??? type: preonly ??? maximum iterations=5000, initial guess is zero ??? tolerances:? relative=1e-08, absolute=1e-08, divergence=10000. ??? left preconditioning ??? using NONE norm type for convergence test ? PC Object: 1 MPI processes ??? type: lu ????? out-of-place factorization ????? tolerance for zero pivot 2.22045e-14 ????? matrix ordering: nd ????? factor fill ratio given 0., needed 0. ??????? Factored matrix follows: ????????? Mat Object: 1 MPI processes ??????????? type: mkl_pardiso ??????????? rows=108000, cols=108000 ??????????? package used to perform factorization: mkl_pardiso ??????????? total: nonzeros=2868000, allocated nonzeros=2868000 ??????????? total number of mallocs used during MatSetValues calls =0 ????????????? MKL_PARDISO run parameters: ????????????? MKL_PARDISO phase:???????????? 33 ????????????? MKL_PARDISO iparm[1]:???? 1 ????????????? MKL_PARDISO iparm[2]:???? 2 ????????????? MKL_PARDISO iparm[3]:???? 2 ????????????? MKL_PARDISO iparm[4]:???? 0 ????????????? MKL_PARDISO iparm[5]:???? 0 ????????????? MKL_PARDISO iparm[6]:???? 0 ????????????? MKL_PARDISO iparm[7]:???? 0 ????????????? MKL_PARDISO iparm[8]:???? 0 ????????????? MKL_PARDISO iparm[9]:???? 0 ????????????? MKL_PARDISO iparm[10]:???? 13 ????????????? MKL_PARDISO iparm[11]:???? 1 ????????????? MKL_PARDISO iparm[12]:???? 0 ????????????? MKL_PARDISO iparm[13]:???? 1 ????????????? MKL_PARDISO iparm[14]:???? 0 ????????????? MKL_PARDISO iparm[15]:???? 232829 ????????????? MKL_PARDISO iparm[16]:???? 150886 ????????????? MKL_PARDISO iparm[17]:???? 2171171 ????????????? MKL_PARDISO iparm[18]:???? 272581106 ????????????? MKL_PARDISO iparm[19]:???? 892866 ????????????? MKL_PARDISO iparm[20]:???? 0 ????????????? MKL_PARDISO iparm[21]:???? 0 ????????????? MKL_PARDISO iparm[22]:???? 0 ????????????? MKL_PARDISO iparm[23]:???? 0 ????????????? MKL_PARDISO iparm[24]:???? 0 ????????????? MKL_PARDISO iparm[25]:???? 0 ????????????? MKL_PARDISO iparm[26]:???? 0 ????????????? MKL_PARDISO iparm[27]:???? 0 ????????????? MKL_PARDISO iparm[28]:???? 0 ????????????? MKL_PARDISO iparm[29]:???? 0 ????????????? MKL_PARDISO iparm[30]:???? 0 ????????????? MKL_PARDISO iparm[31]:???? 0 ????????????? MKL_PARDISO iparm[32]:???? 0 ????????????? MKL_PARDISO iparm[33]:???? 0 ????????????? MKL_PARDISO iparm[34]:???? -1 ????????????? MKL_PARDISO iparm[35]:???? 1 ????????????? MKL_PARDISO iparm[36]:???? 0 ????????????? MKL_PARDISO iparm[37]:???? 0 ????????????? MKL_PARDISO iparm[38]:???? 0 ????????????? MKL_PARDISO iparm[39]:???? 0 ????????????? MKL_PARDISO iparm[40]:???? 0 ????????????? MKL_PARDISO iparm[41]:???? 0 ????????????? MKL_PARDISO iparm[42]:???? 0 ????????????? MKL_PARDISO iparm[43]:???? 0 ????????????? MKL_PARDISO iparm[44]:???? 0 ????????????? MKL_PARDISO iparm[45]:???? 0 ????????????? MKL_PARDISO iparm[46]:???? 0 ????????????? MKL_PARDISO iparm[47]:???? 0 ????????????? MKL_PARDISO iparm[48]:???? 0 ????????????? MKL_PARDISO iparm[49]:???? 0 ????????????? MKL_PARDISO iparm[50]:???? 0 ????????????? MKL_PARDISO iparm[51]:???? 0 ????????????? MKL_PARDISO iparm[52]:???? 0 ????????????? MKL_PARDISO iparm[53]:???? 0 ????????????? MKL_PARDISO iparm[54]:???? 0 ????????????? MKL_PARDISO iparm[55]:???? 0 ????????????? MKL_PARDISO iparm[56]:???? 0 ????????????? MKL_PARDISO iparm[57]:???? -1 ????????????? MKL_PARDISO iparm[58]:???? 0 ????????????? MKL_PARDISO iparm[59]:???? 0 ????????????? MKL_PARDISO iparm[60]:???? 0 ????????????? MKL_PARDISO iparm[61]:???? 232829 ????????????? MKL_PARDISO iparm[62]:???? 103811 ????????????? MKL_PARDISO iparm[63]:???? 0 ????????????? MKL_PARDISO iparm[64]:???? 0 ????????????? MKL_PARDISO maxfct:???? 1 ????????????? MKL_PARDISO mnum:???? 1 ????????????? MKL_PARDISO mtype:???? 11 ????????????? MKL_PARDISO n:???? 108000 ????????????? MKL_PARDISO nrhs:???? 1 ????????????? MKL_PARDISO msglvl:???? 0 ??? linear system matrix = precond matrix: ??? Mat Object: 1 MPI processes ????? type: seqaij ????? rows=108000, cols=108000 ????? total: nonzeros=2868000, allocated nonzeros=8640000 ????? total number of mallocs used during MatSetValues calls =0 ??????? not using I-node routines ************************************************************************************************************************ ***???????????? WIDEN YOUR WINDOW TO 120 CHARACTERS.? Use 'enscript -r -fCourier9' to print this document??????????? *** ************************************************************************************************************************ ---------------------------------------------- PETSc Performance Summary: ---------------------------------------------- E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a? named ALIREZA-PC with 1 processor, by AliReza Tue Aug 28 00:43:44 2018 Using Petsc Release Version 3.9.3, Jul, 02, 2018 ???????????????????????? Max?????? Max/Min??????? Avg????? Total Time (sec):?????????? 3.180e+02????? 1.00000?? 3.180e+02 Objects:????????????? 2.400e+01????? 1.00000?? 2.400e+01 Flop:???????????????? 7.032e+06????? 1.00000?? 7.032e+06? 7.032e+06 Flop/sec:??????????? 2.211e+04????? 1.00000?? 2.211e+04? 2.211e+04 MPI Messages:???????? 0.000e+00????? 0.00000?? 0.000e+00? 0.000e+00 MPI Message Lengths:? 0.000e+00????? 0.00000?? 0.000e+00? 0.000e+00 MPI Reductions:?????? 0.000e+00????? 0.00000 Flop counting convention: 1 flop = 1 real number operation of type (multiply/divide/add/subtract) ??????????????????????????? e.g., VecAXPY() for real vectors of length N --> 2N flop ??????????????????????????? and VecAXPY() for complex vectors of length N --> 8N flop Summary of Stages:?? ----- Time ------? ----- Flop -----? --- Messages ---? -- Message Lengths --? -- Reductions -- ??????????????????????? Avg???? %Total???? Avg???? %Total?? counts %Total???? Avg???????? %Total?? counts?? %Total ?0:????? Main Stage: 3.1802e+02 100.0%? 7.0320e+06 100.0% 0.000e+00?? 0.0%? 0.000e+00??????? 0.0%? 0.000e+00?? 0.0% ------------------------------------------------------------------------------------------------------------------------ See the 'Profiling' chapter of the users' manual for details on interpreting output. Phase summary info: ?? Count: number of times phase was executed ?? Time and Flop: Max - maximum over all processors ?????????????????? Ratio - ratio of maximum to minimum over all processors ?? Mess: number of messages sent ?? Avg. len: average message length (bytes) ?? Reduct: number of global reductions ?? Global: entire computation ?? Stage: stages of a computation. Set stages with PetscLogStagePush() and PetscLogStagePop(). ????? %T - percent time in this phase???????? %F - percent flop in this phase ????? %M - percent messages in this phase???? %L - percent message lengths in this phase ????? %R - percent reductions in this phase ?? Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time over all processors) ------------------------------------------------------------------------------------------------------------------------ Event??????????????? Count????? Time (sec) Flop???????????????????????????? --- Global ---? --- Stage --- Total ?????????????????? Max Ratio? Max???? Ratio?? Max? Ratio? Mess?? Avg len Reduct? %T %F %M %L %R? %T %F %M %L %R Mflop/s ------------------------------------------------------------------------------------------------------------------------ --- Event Stage 0: Main Stage BuildTwoSidedF???????? 2 1.0 2.2665e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 SNESSolve????????????? 1 1.0 2.9114e+02 1.0 7.03e+06 1.0 0.0e+00 0.0e+00 0.0e+00 92100? 0? 0? 0? 92100? 0? 0? 0???? 0 SNESFunctionEval?????? 2 1.0 1.3104e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 SNESJacobianEval?????? 1 1.0 9.1535e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 29? 0? 0? 0? 0? 29? 0? 0? 0? 0???? 0 SNESLineSearch???????? 1 1.0 1.9715e+01 1.0 6.82e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 6 97? 0? 0? 0?? 6 97? 0? 0? 0???? 0 VecDot???????????????? 1 1.0 7.6773e-01 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0???? 0 VecNorm??????????????? 3 1.0 3.8735e-02 1.0 6.48e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 9? 0? 0? 0?? 0? 9? 0? 0? 0??? 17 VecCopy??????????????? 2 1.0 6.6713e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecSet???????????????? 1 1.0 1.6375e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecWAXPY?????????????? 1 1.0 1.3113e-02 1.0 1.08e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 8 VecAssemblyBegin?????? 2 1.0 3.4640e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecAssemblyEnd???????? 2 1.0 6.4148e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecReduceArith???????? 2 1.0 5.0032e-01 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 6? 0? 0? 0?? 0? 6? 0? 0? 0???? 1 VecReduceComm????????? 1 1.0 2.8122e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatMult??????????????? 1 1.0 4.8387e+00 1.0 5.63e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 2 80? 0? 0? 0?? 2 80? 0? 0? 0???? 1 MatSolve?????????????? 1 1.0 5.9153e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 19? 0? 0? 0? 0? 19? 0? 0? 0? 0???? 0 MatLUFactorSym???????? 1 1.0 1.9012e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 MatLUFactorNum???????? 1 1.0 1.0291e+02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 32? 0? 0? 0? 0? 32? 0? 0? 0? 0???? 0 MatAssemblyBegin?????? 2 1.0 8.5530e-07 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatAssemblyEnd???????? 2 1.0 2.5865e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatGetRowIJ??????????? 1 1.0 1.2557e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatGetOrdering???????? 1 1.0 1.3958e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatZeroEntries???????? 1 1.0 2.0895e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatView??????????????? 2 1.0 1.4709e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 KSPSetUp?????????????? 1 1.0 4.2765e-07 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 KSPSolve?????????????? 1 1.0 1.7075e+02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 54? 0? 0? 0? 0? 54? 0? 0? 0? 0???? 0 PCSetUp??????????????? 1 1.0 1.0949e+02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 34? 0? 0? 0? 0? 34? 0? 0? 0? 0???? 0 PCApply??????????????? 1 1.0 5.9153e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 19? 0? 0? 0? 0? 19? 0? 0? 0? 0???? 0 ------------------------------------------------------------------------------------------------------------------------ Memory usage is given in bytes: Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. Reports information only for process 0. --- Event Stage 0: Main Stage ??????????????? SNES???? 1????????????? 0??????????? 0???? 0. ????? SNESLineSearch???? 1????????????? 0??????????? 0???? 0. ????????????? DMSNES???? 1????????????? 0??????????? 0???? 0. ????????????? Vector???? 5????????????? 0??????????? 0???? 0. ????????????? Matrix???? 2????????????? 0??????????? 0???? 0. ??? Distributed Mesh???? 2????????????? 0??????????? 0???? 0. ?????????? Index Set???? 2????????????? 0??????????? 0???? 0. ?? Star Forest Graph???? 4????????????? 0??????????? 0???? 0. ???? Discrete System???? 2????????????? 0??????????? 0???? 0. ?????? Krylov Solver???? 1????????????? 0??????????? 0???? 0. ???? DMKSP interface???? 1????????????? 0??????????? 0???? 0. ????? Preconditioner???? 1????????????? 0??????????? 0???? 0. ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. ======================================================================================================================== Average time to get PetscTime(): 8.55301e-08 #PETSc Option Table entries: -ksp_atol 1e-6 -ksp_rtol 1e-5 -pc_factor_mat_solver_type mkl_pardiso -pc_type lu -snes_rtol 1e-4 #End of PETSc Option Table entries Compiled without FORTRAN kernels Compiled with full precision matrices (default) sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 sizeof(PetscScalar) 8 sizeof(PetscInt) 4 Configure options: --prefix=/home/alireza/Petsc393Install --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl --with-hyp re-include=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos-master/ Bins/include --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdrive/E/Pro gram_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/ mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debugging=0 --wi th-blas-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_x86/Inte lSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 -Qopenmp" ----------------------------------------- Libraries compiled on 2018-08-21 12:07:21 on AliReza-PC Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit Using PETSc directory: /home/alireza/Petsc393Install Using PETSc arch: ----------------------------------------- Using C compiler: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl -O2 -MT -wd4996 -Qopenmp Using Fortran compiler: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp -fpp ----------------------------------------- Using include paths: -I/home/alireza/Petsc393Install/include -I/home/alireza/Petsc393Install//include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries /windows/mkl/include -I/cygdrive/E/hypre-2.11.2/Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_ libraries/windows/mpi/intel64/include ----------------------------------------- Using C linker: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe icl Using Fortran linker: /home/alireza/petsc-3.9.3/lib/petsc/bin/win32fe/win32fe ifort Using libraries: -L/home/alireza/Petsc393Install/lib -L/home/alireza/Petsc393Install/lib -lpetsc /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib /cygdrive/E/Trilinos-m aster/Bins/lib/ml.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools /compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Gdi32. lib User32.lib Advapi32.lib Kernel32.lib Ws2_32.lib ----------------------------------------- From bsmith at mcs.anl.gov Mon Aug 27 16:19:06 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Mon, 27 Aug 2018 21:19:06 +0000 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <871saj1pxq.fsf@jedbrown.org> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> Message-ID: <6E0F44EA-A2D1-4C7C-AA8D-F3F0C1FD7A55@mcs.anl.gov> > On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: > > "Smith, Barry F." writes: > >> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c > > Note that this example is block Jacobi with O(1) sparse blocks per > process, not variable-sized point-block Jacobi which I think is what Ali > had in mind. It is almost a cut and paste of the original code provided, just set up as a callback. If it performs well convergence wise then one could consider implementing the (presumably) more efficient variable blocksize point block Jacobi (either as an entirely new preconditioner or as an option to the current point block Jacobi; I would advocate a new one PCVPBJACOBI in order to limit code complexity even though there might be a bit of code duplication.) > >> Please let us know if it works for you and if you have any questions or problems. >> >> Barry >> >> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >> >> Sorry for the runaround with so many emails. >> >> >>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>> >>> Hi, >>> >>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>> >>> Below is a part of my code. It is run serially. Any help is much appreciated. >>> >>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>> CHKERRQ(ierr); >>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>> CHKERRQ(ierr); >>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>> CHKERRQ(ierr); >>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>> CHKERRQ(ierr); >>> ierr = SNESSetType(snes, SNESNEWTONLS); >>> CHKERRQ(ierr); >>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>> CHKERRQ(ierr); >>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>> CHKERRQ(ierr); >>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>> CHKERRQ(ierr); >>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>> CHKERRQ(ierr); >>> >>> SNESSetUp(snes); >>> CHKERRQ(ierr); >>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>> CHKERRQ(ierr); >>> >>> for (i = 0; i < nLocal; i++) { >>> ierr = KSPGetPC(subKSP[i], &SubPc); >>> CHKERRQ(ierr); >>> ierr = PCSetType(SubPc, PCLU); >>> CHKERRQ(ierr); >>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>> CHKERRQ(ierr); >>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>> CHKERRQ(ierr); >>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>> CHKERRQ(ierr); >>> } >>> ierr = SNESSolve(snes, NULL, Petsc_X); >>> CHKERRQ(ierr); >>> >>> >>> >>> -- >>> Ali Reza Khaz?ali >>> Assistant Professor of Petroleum Engineering, >>> Department of Chemical Engineering >>> Isfahan University of Technology >>> Isfahan, Iran >>> From jed at jedbrown.org Mon Aug 27 16:32:43 2018 From: jed at jedbrown.org (Jed Brown) Date: Mon, 27 Aug 2018 15:32:43 -0600 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <6E0F44EA-A2D1-4C7C-AA8D-F3F0C1FD7A55@mcs.anl.gov> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <6E0F44EA-A2D1-4C7C-AA8D-F3F0C1FD7A55@mcs.anl.gov> Message-ID: <87tvnfsdfo.fsf@jedbrown.org> "Smith, Barry F." writes: >> On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: >> >> "Smith, Barry F." writes: >> >>> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c >> >> Note that this example is block Jacobi with O(1) sparse blocks per >> process, not variable-sized point-block Jacobi which I think is what Ali >> had in mind. > > It is almost a cut and paste of the original code provided, just > set up as a callback. Yeah, but each of these blocks would be less than 10x10. PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); > If it performs well convergence wise then Yes. > one could consider implementing the (presumably) more efficient > variable blocksize point block Jacobi (either as an entirely new > preconditioner or as an option to the current point block Jacobi; > I would advocate a new one PCVPBJACOBI in order to limit code > complexity even though there might be a bit of code duplication.) Yeah, possibly. We'd need MatInvertBlockDiagonal (or a generalization) to be able to return a variable block size at which point it's almost the same. From mvalera-w at sdsu.edu Mon Aug 27 17:51:40 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Mon, 27 Aug 2018 15:51:40 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> Message-ID: Hello everyone, I just had time to work on this again, and checked the code for errors on the matrix entries, this is the exact code i was using for creating the matrix without DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and it worked that way, but trying this way i get the same 'Column too large' error using any number at the column position of MatSetValues, I have set up my code to print the column argument (n) of MatSetValues and in this case is 7 (lower than 124), it still gives error, even entering a specific number in the MatSetValues column argument position gives the same error. So next i went back to ex.50 here: http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html and it has a very similar structure except the PetscMalloc1() call, so i tried adding that and got: /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined reference to `petscmalloc1_' Any ideas on this behaviour? Thanks so much, On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. wrote: > > Column too large: col 10980 max 124 > > You need to check the code that is generating the matrix entries. The > matrix has 124 columns but you are attempting to put a value at column 10980 > > Barry > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera wrote: > > > > Thanks Matthew and Barry, > > > > Now my code looks like: > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > call DMCreateMatrix(daDummy,A,ierr) > > call MatSetFromOptions(A,ierr) > > call MatSetUp(A,ierr) > > [...] > > call MatSetValues(A,1,row,sumpos, > pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > [...] > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > And i get a different error, now is: > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [0]PETSC ERROR: Argument out of range > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 15 19:40:00 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > wrote: > > > > Should be > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > call DMCreateMatrix(daDummy,A,ierr) > > > > and remove the rest. You need to set the type of Mat you want the DM > to return BEFORE you create the matrix. > > > > Barry > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera wrote: > > > > > > Ok thanks for clarifying that, i wasn't sure if there were different > types, > > > > > > Here is a stripped down version of my code, it seems like the > preallocation is working now since the matrix population part is working > without problem, but here it is for illustration purposes: > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > call DMCreateMatrix(daDummy,A,ierr) > > > call MatSetFromOptions(A,ierr) > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > call MatSetUp(A,ierr) > > > [...] > > > call MatSetValues(A,1,row,sumpos, > pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > [...] > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > Adding the first line there did the trick, > > > > > > Now the problem seems to be the program is not recognizing the matrix > as ViennaCL type when i try with more than one processor, i get now: > > > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > [0]PETSC ERROR: No support for this operation for this object type > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Wed Aug 15 14:44:22 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ > ksp/interface/itfunc.c > > > > > > When running with: > > > > > > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ > jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type > aijviennacl -pc_type saviennacl -log_view > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > wrote: > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > wrote: > > > It seems to be resumed on: I do not know how to preallocate a DM > Matrix correctly. > > > > > > There is only one matrix type, Mat. There are no separate DM matrices. > A DM can create a matrix for you > > > using DMCreateMatrix(), but that is a Mat and it is preallocated > correctly. I am not sure what you are doing. > > > > > > Thanks, > > > > > > Matt > > > > > > The interesting part is that it only breaks when i need to populate a > GPU matrix from MPI, so kudos on that, but it seems i need to do better on > my code to get this setup working, > > > > > > Any help would be appreciated, > > > > > > Thanks, > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > wrote: > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > wrote: > > > Thanks Matthew, > > > > > > I try to do that when calling: > > > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > But i am not aware on how to do this for the DM if it needs something > more specific/different, > > > > > > The error says that your preallocation is wrong for the values you are > putting in. The DM does not control either, > > > so I do not understand your email. > > > > > > Thanks, > > > > > > Matt > > > > > > Thanks, > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > wrote: > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > wrote: > > > Hello PETSc devs, > > > > > > I am running into an error when trying to use the MATMPIAIJVIENNACL > Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in > one processor. The error happens when calling MatSetValues for this > specific configuration. It does not occur when using MPI DMMatrix types > only. > > > > > > The DM properly preallocates the matrix. I am assuming you do not here. > > > > > > Matt > > > > > > Any help will be appreciated, > > > > > > Thanks, > > > > > > > > > > > > My program call: > > > > > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ > jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type > aijviennacl -pc_type saviennacl -log_view > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > [1]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > [1]PETSC ERROR: Argument out of range > > > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) > into matrix > > > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Wed Aug 15 13:10:44 2018 > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > My Code structure: > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > call MatSetFromOptions(A,ierr) > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > if (numprocs > 1) then ! set matrix type parallel > > > ! Get local size > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > call VecDestroy(Tmpnat,ierr) > > > ! Set matrix > > > #ifdef GPU > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > print*,'SETTING GPU TYPES' > > > #else > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > #endif > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > else ! set matrix type sequential > > > #ifdef GPU > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > print*,'SETTING GPU TYPES' > > > #else > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > call MatSetType(A,MATSEQAIJ,ierr) > > > #endif > > > call MatSetUp(A,ierr) > > > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > do k=zstart,zend-1 > > > do j=ystart,yend-1 > > > do i=xstart,xend-1 > > > [..] > > > call MatSetValues(A,1,row,sumpos, > pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > [..] > > > > > > > > > > > > > > > > > > > > > -- > > > 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 > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > -- > > > 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 > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > -- > > > 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 > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Mon Aug 27 19:12:21 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Tue, 28 Aug 2018 00:12:21 +0000 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> Message-ID: <9DAE7720-48CA-4E9E-9760-6B681951D33B@anl.gov> Actually you do not need my new branch to achieve what you desired. All you need in your main program is something like ierr = SNESCreate(PETSC_COMM_WORLD,&snes);CHKERRQ(ierr); ierr = SNESGetKSP(snes,&ksp);CHKERRQ(ierr); ierr = KSPGetPC(ksp,&pc);CHKERRQ(ierr); ierr = PCSetType(pc,PCBJACOBI);CHKERRQ(ierr); ierr = PCBJacobiSetTotalBlocks(pc,3,lens);CHKERRQ(ierr); /* here you set your block sizes to whatever you need */ Then simply do not call PCBJacobiGetSubKSP() but use the options database to set the inner solver with -sub_pc_type lu -sub_ksp_type preonly I have updated the branch to move the PCBJacobiSetTotalBlocks() to the main program but left the callback in there for setting the inner solver types (though as I just said you don't need to use the callback since you can control the solver from the options database). The callback is needed, if, for example, you wished to use a different solver on different blocks (which is not your case). Barry PETSc developers - do you think we should put the callback functionality into PETSc? It allows doing things that are otherwise not doable but is rather ugly (perhaps too specialized)? > On Aug 27, 2018, at 4:01 PM, Smith, Barry F. wrote: > > > I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c > > Please let us know if it works for you and if you have any questions or problems. > > Barry > > Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. > > Sorry for the runaround with so many emails. > > >> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >> >> Hi, >> >> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >> >> Below is a part of my code. It is run serially. Any help is much appreciated. >> >> ierr = SNESGetKSP(snes, &Petsc_ksp); >> CHKERRQ(ierr); >> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >> CHKERRQ(ierr); >> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >> CHKERRQ(ierr); >> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >> CHKERRQ(ierr); >> ierr = SNESSetType(snes, SNESNEWTONLS); >> CHKERRQ(ierr); >> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >> CHKERRQ(ierr); >> ierr = PCSetType(Petsc_pc, PCBJACOBI); >> CHKERRQ(ierr); >> ierr = PCSetType(Petsc_pc, PCBJACOBI); >> CHKERRQ(ierr); >> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >> CHKERRQ(ierr); >> >> SNESSetUp(snes); >> CHKERRQ(ierr); >> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >> CHKERRQ(ierr); >> >> for (i = 0; i < nLocal; i++) { >> ierr = KSPGetPC(subKSP[i], &SubPc); >> CHKERRQ(ierr); >> ierr = PCSetType(SubPc, PCLU); >> CHKERRQ(ierr); >> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >> CHKERRQ(ierr); >> ierr = KSPSetType(subKSP[i], KSPPREONLY); >> CHKERRQ(ierr); >> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >> CHKERRQ(ierr); >> } >> ierr = SNESSolve(snes, NULL, Petsc_X); >> CHKERRQ(ierr); >> >> >> >> -- >> Ali Reza Khaz?ali >> Assistant Professor of Petroleum Engineering, >> Department of Chemical Engineering >> Isfahan University of Technology >> Isfahan, Iran >> > From knepley at gmail.com Mon Aug 27 19:35:38 2018 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 27 Aug 2018 20:35:38 -0400 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> Message-ID: On Mon, Aug 27, 2018 at 6:51 PM Manuel Valera wrote: > Hello everyone, > > I just had time to work on this again, and checked the code for errors on > the matrix entries, this is the exact code i was using for creating the > matrix without DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation > and it worked that way, but trying this way i get the same 'Column too > large' error using any number at the column position of MatSetValues, > > I have set up my code to print the column argument (n) of MatSetValues and > in this case is 7 (lower than 124), it still gives error, even entering a > specific number in the MatSetValues column argument position gives the same > error. > > So next i went back to ex.50 here: > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html > and it has a very similar structure except the PetscMalloc1() call, so i > tried adding that and got: > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined reference to > `petscmalloc1_' > > Any ideas on this behaviour? > This is a macro. I am guessing you are using Fortran. Just use PetscMalloc instead. Thanks, Matt > Thanks so much, > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > wrote: > >> >> Column too large: col 10980 max 124 >> >> You need to check the code that is generating the matrix entries. The >> matrix has 124 columns but you are attempting to put a value at column 10980 >> >> Barry >> >> >> > On Aug 15, 2018, at 9:44 PM, Manuel Valera wrote: >> > >> > Thanks Matthew and Barry, >> > >> > Now my code looks like: >> > >> > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >> > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > call DMCreateMatrix(daDummy,A,ierr) >> > call MatSetFromOptions(A,ierr) >> > call MatSetUp(A,ierr) >> > [...] >> > call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> > [...] >> > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > >> > And i get a different error, now is: >> > >> > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > [0]PETSC ERROR: Argument out of range >> > [0]PETSC ERROR: Column too large: col 10980 max 124 >> > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >> Aug 15 19:40:00 2018 >> > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in >> /home/valera/petsc/src/mat/impls/aij/seq/aij.c >> > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >> /home/valera/petsc/src/mat/interface/matrix.c >> > >> > >> > Thanks again, >> > >> > >> > >> > >> > >> > >> > >> > >> > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. >> wrote: >> > >> > Should be >> > >> > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > call DMCreateMatrix(daDummy,A,ierr) >> > >> > and remove the rest. You need to set the type of Mat you want the DM >> to return BEFORE you create the matrix. >> > >> > Barry >> > >> > >> > >> > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >> wrote: >> > > >> > > Ok thanks for clarifying that, i wasn't sure if there were different >> types, >> > > >> > > Here is a stripped down version of my code, it seems like the >> preallocation is working now since the matrix population part is working >> without problem, but here it is for illustration purposes: >> > > >> > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >> > > call DMCreateMatrix(daDummy,A,ierr) >> > > call MatSetFromOptions(A,ierr) >> > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >> > > call MatSetUp(A,ierr) >> > > [...] >> > > call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> > > [...] >> > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > > >> > > Adding the first line there did the trick, >> > > >> > > Now the problem seems to be the program is not recognizing the matrix >> as ViennaCL type when i try with more than one processor, i get now: >> > > >> > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > [0]PETSC ERROR: No support for this operation for this object type >> > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >> > > [0]PETSC ERROR: See >> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >> > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Wed Aug 15 14:44:22 2018 >> > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >> /home/valera/petsc/src/ksp/pc/interface/precon.c >> > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >> > > >> > > When running with: >> > > >> > > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >> aijviennacl -pc_type saviennacl -log_view >> > > >> > > >> > > Thanks, >> > > >> > > >> > > >> > > >> > > >> > > >> > > >> > > >> > > >> > > >> > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley >> wrote: >> > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >> wrote: >> > > It seems to be resumed on: I do not know how to preallocate a DM >> Matrix correctly. >> > > >> > > There is only one matrix type, Mat. There are no separate DM >> matrices. A DM can create a matrix for you >> > > using DMCreateMatrix(), but that is a Mat and it is preallocated >> correctly. I am not sure what you are doing. >> > > >> > > Thanks, >> > > >> > > Matt >> > > >> > > The interesting part is that it only breaks when i need to populate a >> GPU matrix from MPI, so kudos on that, but it seems i need to do better on >> my code to get this setup working, >> > > >> > > Any help would be appreciated, >> > > >> > > Thanks, >> > > >> > > >> > > >> > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >> wrote: >> > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >> wrote: >> > > Thanks Matthew, >> > > >> > > I try to do that when calling: >> > > >> > > call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >> > > >> > > But i am not aware on how to do this for the DM if it needs something >> more specific/different, >> > > >> > > The error says that your preallocation is wrong for the values you >> are putting in. The DM does not control either, >> > > so I do not understand your email. >> > > >> > > Thanks, >> > > >> > > Matt >> > > >> > > Thanks, >> > > >> > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >> wrote: >> > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >> wrote: >> > > Hello PETSc devs, >> > > >> > > I am running into an error when trying to use the MATMPIAIJVIENNACL >> Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in >> one processor. The error happens when calling MatSetValues for this >> specific configuration. It does not occur when using MPI DMMatrix types >> only. >> > > >> > > The DM properly preallocates the matrix. I am assuming you do not >> here. >> > > >> > > Matt >> > > >> > > Any help will be appreciated, >> > > >> > > Thanks, >> > > >> > > >> > > >> > > My program call: >> > > >> > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >> aijviennacl -pc_type saviennacl -log_view >> > > >> > > >> > > The error (repeats after each MatSetValues call): >> > > >> > > [1]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > [1]PETSC ERROR: Argument out of range >> > > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) >> into matrix >> > > [1]PETSC ERROR: See >> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >> > > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Wed Aug 15 13:10:44 2018 >> > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >> > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >> /home/valera/petsc/src/mat/interface/matrix.c >> > > >> > > >> > > My Code structure: >> > > >> > > call DMCreateMatrix(daDummy,A,ierr) >> > > call MatSetFromOptions(A,ierr) >> > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >> > > if (numprocs > 1) then ! set matrix type parallel >> > > ! Get local size >> > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >> > > call VecGetLocalSize(Tmpnat,locsize,ierr) >> > > call VecDestroy(Tmpnat,ierr) >> > > ! Set matrix >> > > #ifdef GPU >> > > call MatSetType(A,MATAIJVIENNACL,ierr) >> > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > print*,'SETTING GPU TYPES' >> > > #else >> > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >> > > call DMSetMatType(daDummy,VECMPI,ierr) >> > > call MatSetType(A,MATMPIAIJ,ierr)! >> > > #endif >> > > call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >> > > else ! set matrix type sequential >> > > #ifdef GPU >> > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >> > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >> > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >> > > print*,'SETTING GPU TYPES' >> > > #else >> > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >> > > call DMSetMatType(daDummy,VECSEQ,ierr) >> > > call MatSetType(A,MATSEQAIJ,ierr) >> > > #endif >> > > call MatSetUp(A,ierr) >> > > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >> > > >> > > do k=zstart,zend-1 >> > > do j=ystart,yend-1 >> > > do i=xstart,xend-1 >> > > [..] >> > > call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> > > [..] >> > > >> > > >> > > >> > > >> > > >> > > >> > > -- >> > > 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 >> > > >> > > https://www.cse.buffalo.edu/~knepley/ >> > > >> > > >> > > >> > > -- >> > > 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 >> > > >> > > https://www.cse.buffalo.edu/~knepley/ >> > > >> > > >> > > >> > > -- >> > > 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 >> > > >> > > https://www.cse.buffalo.edu/~knepley/ >> > > >> > >> > >> >> > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Mon Aug 27 21:35:03 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Tue, 28 Aug 2018 02:35:03 +0000 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> Message-ID: <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> Send your code in a way we can compile and run it; it must be some simple issue that is hard to communicate in email. Barry > On Aug 27, 2018, at 5:51 PM, Manuel Valera wrote: > > Hello everyone, > > I just had time to work on this again, and checked the code for errors on the matrix entries, this is the exact code i was using for creating the matrix without DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and it worked that way, but trying this way i get the same 'Column too large' error using any number at the column position of MatSetValues, > > I have set up my code to print the column argument (n) of MatSetValues and in this case is 7 (lower than 124), it still gives error, even entering a specific number in the MatSetValues column argument position gives the same error. > > So next i went back to ex.50 here: http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html and it has a very similar structure except the PetscMalloc1() call, so i tried adding that and got: > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined reference to `petscmalloc1_' > > Any ideas on this behaviour? > > Thanks so much, > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. wrote: > > Column too large: col 10980 max 124 > > You need to check the code that is generating the matrix entries. The matrix has 124 columns but you are attempting to put a value at column 10980 > > Barry > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera wrote: > > > > Thanks Matthew and Barry, > > > > Now my code looks like: > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > call DMCreateMatrix(daDummy,A,ierr) > > call MatSetFromOptions(A,ierr) > > call MatSetUp(A,ierr) > > [...] > > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > [...] > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > And i get a different error, now is: > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [0]PETSC ERROR: Argument out of range > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 19:40:00 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in /home/valera/petsc/src/mat/interface/matrix.c > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. wrote: > > > > Should be > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > call DMCreateMatrix(daDummy,A,ierr) > > > > and remove the rest. You need to set the type of Mat you want the DM to return BEFORE you create the matrix. > > > > Barry > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera wrote: > > > > > > Ok thanks for clarifying that, i wasn't sure if there were different types, > > > > > > Here is a stripped down version of my code, it seems like the preallocation is working now since the matrix population part is working without problem, but here it is for illustration purposes: > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > call DMCreateMatrix(daDummy,A,ierr) > > > call MatSetFromOptions(A,ierr) > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > call MatSetUp(A,ierr) > > > [...] > > > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > [...] > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > Adding the first line there did the trick, > > > > > > Now the problem seems to be the program is not recognizing the matrix as ViennaCL type when i try with more than one processor, i get now: > > > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > [0]PETSC ERROR: No support for this operation for this object type > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 14:44:22 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > When running with: > > > > > > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley wrote: > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera wrote: > > > It seems to be resumed on: I do not know how to preallocate a DM Matrix correctly. > > > > > > There is only one matrix type, Mat. There are no separate DM matrices. A DM can create a matrix for you > > > using DMCreateMatrix(), but that is a Mat and it is preallocated correctly. I am not sure what you are doing. > > > > > > Thanks, > > > > > > Matt > > > > > > The interesting part is that it only breaks when i need to populate a GPU matrix from MPI, so kudos on that, but it seems i need to do better on my code to get this setup working, > > > > > > Any help would be appreciated, > > > > > > Thanks, > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley wrote: > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera wrote: > > > Thanks Matthew, > > > > > > I try to do that when calling: > > > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > But i am not aware on how to do this for the DM if it needs something more specific/different, > > > > > > The error says that your preallocation is wrong for the values you are putting in. The DM does not control either, > > > so I do not understand your email. > > > > > > Thanks, > > > > > > Matt > > > > > > Thanks, > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley wrote: > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera wrote: > > > Hello PETSc devs, > > > > > > I am running into an error when trying to use the MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in one processor. The error happens when calling MatSetValues for this specific configuration. It does not occur when using MPI DMMatrix types only. > > > > > > The DM properly preallocates the matrix. I am assuming you do not here. > > > > > > Matt > > > > > > Any help will be appreciated, > > > > > > Thanks, > > > > > > > > > > > > My program call: > > > > > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > [1]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > [1]PETSC ERROR: Argument out of range > > > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) into matrix > > > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 13:10:44 2018 > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > My Code structure: > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > call MatSetFromOptions(A,ierr) > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > if (numprocs > 1) then ! set matrix type parallel > > > ! Get local size > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > call VecDestroy(Tmpnat,ierr) > > > ! Set matrix > > > #ifdef GPU > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > print*,'SETTING GPU TYPES' > > > #else > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > #endif > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > else ! set matrix type sequential > > > #ifdef GPU > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > print*,'SETTING GPU TYPES' > > > #else > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > call MatSetType(A,MATSEQAIJ,ierr) > > > #endif > > > call MatSetUp(A,ierr) > > > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > do k=zstart,zend-1 > > > do j=ystart,yend-1 > > > do i=xstart,xend-1 > > > [..] > > > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > [..] > > > > > > > > > > > > > > > > > > > > > -- > > > 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 > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > -- > > > 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 > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > -- > > > 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 > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > From arkhazali at cc.iut.ac.ir Tue Aug 28 04:34:08 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Tue, 28 Aug 2018 14:04:08 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <9DAE7720-48CA-4E9E-9760-6B681951D33B@anl.gov> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <9DAE7720-48CA-4E9E-9760-6B681951D33B@anl.gov> Message-ID: <39cf6b2d-76f8-daac-4634-6d60bcfdec41@cc.iut.ac.ir> > Actually you do not need my new branch to achieve what you desired. All you need in your main program is something like > > ierr = SNESCreate(PETSC_COMM_WORLD,&snes);CHKERRQ(ierr); > ierr = SNESGetKSP(snes,&ksp);CHKERRQ(ierr); > ierr = KSPGetPC(ksp,&pc);CHKERRQ(ierr); > ierr = PCSetType(pc,PCBJACOBI);CHKERRQ(ierr); > ierr = PCBJacobiSetTotalBlocks(pc,3,lens);CHKERRQ(ierr); /* here you set your block sizes to whatever you need */ > > Then simply do not call PCBJacobiGetSubKSP() but use the options database to set the inner solver with -sub_pc_type lu -sub_ksp_type preonly > > I have updated the branch to move the PCBJacobiSetTotalBlocks() to the main program but left the callback in there for setting the inner solver types (though as I just said you don't need to use the callback since you can control the solver from the options database). The callback is needed, if, for example, you wished to use a different solver on different blocks (which is not your case). > > Barry > > PETSc developers - do you think we should put the callback functionality into PETSc? It allows doing things that are otherwise not doable but is rather ugly (perhaps too specialized)? > > > It works! Thanks a lot. Here is log of a 30x30x10 system (18000 blocks, with GMRes solver). I like to have variable sized block preconditioners and solvers in PETSc. Their application is more than it may first appear. If it is possible, I would like to contribute to PETSc code, to build a variable sized block Jacobi and block ILU(k) at the first step (If I can, of course). Where can I start? ? type: newtonls ? maximum iterations=2000, maximum function evaluations=2000 ? tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 ? total number of linear solver iterations=3 ? total number of function evaluations=2 ? norm schedule ALWAYS ? SNESLineSearch Object: 1 MPI processes ??? type: bt ????? interpolation: cubic ????? alpha=1.000000e-04 ??? maxstep=1.000000e+08, minlambda=1.000000e-12 ??? tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 ??? maximum iterations=40 ? KSP Object: 1 MPI processes ??? type: gmres ????? restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement ????? happy breakdown tolerance 1e-30 ??? maximum iterations=5000, initial guess is zero ??? tolerances:? relative=1e-05, absolute=1e-06, divergence=10000. ??? left preconditioning ??? using PRECONDITIONED norm type for convergence test ? PC Object: 1 MPI processes ??? type: bjacobi ????? number of blocks = 18000 ????? Local solve is same for all blocks, in the following KSP and PC objects: ????? KSP Object: (sub_) 1 MPI processes ??????? type: preonly ??????? maximum iterations=10000, initial guess is zero ??????? tolerances:? relative=1e-05, absolute=1e-50, divergence=10000. ??????? left preconditioning ??????? using NONE norm type for convergence test ????? PC Object: (sub_) 1 MPI processes ??????? type: lu ????????? out-of-place factorization ????????? tolerance for zero pivot 2.22045e-14 ????????? matrix ordering: nd ????????? factor fill ratio given 0., needed 0. ??????????? Factored matrix follows: ????????????? Mat Object: 1 MPI processes ??????????????? type: mkl_pardiso ??????????????? rows=6, cols=6 ??????????????? package used to perform factorization: mkl_pardiso ??????????????? total: nonzeros=26, allocated nonzeros=26 ??????????????? total number of mallocs used during MatSetValues calls =0 ????????????????? MKL_PARDISO run parameters: ????????????????? MKL_PARDISO phase:???????????? 33 ????????????????? MKL_PARDISO iparm[1]:???? 1 ????????????????? MKL_PARDISO iparm[2]:???? 2 ????????????????? MKL_PARDISO iparm[3]:???? 1 ????????????????? MKL_PARDISO iparm[4]:???? 0 ????????????????? MKL_PARDISO iparm[5]:???? 0 ????????????????? MKL_PARDISO iparm[6]:???? 0 ????????????????? MKL_PARDISO iparm[7]:???? 0 ????????????????? MKL_PARDISO iparm[8]:???? 0 ????????????????? MKL_PARDISO iparm[9]:???? 0 ????????????????? MKL_PARDISO iparm[10]:???? 13 ????????????????? MKL_PARDISO iparm[11]:???? 1 ????????????????? MKL_PARDISO iparm[12]:???? 0 ????????????????? MKL_PARDISO iparm[13]:???? 1 ????????????????? MKL_PARDISO iparm[14]:???? 0 ????????????????? MKL_PARDISO iparm[15]:???? 144 ????????????????? MKL_PARDISO iparm[16]:???? 144 ????????????????? MKL_PARDISO iparm[17]:???? 0 ????????????????? MKL_PARDISO iparm[18]:???? 37 ????????????????? MKL_PARDISO iparm[19]:???? 0 ????????????????? MKL_PARDISO iparm[20]:???? 0 ????????????????? MKL_PARDISO iparm[21]:???? 0 ????????????????? MKL_PARDISO iparm[22]:???? 0 ????????????????? MKL_PARDISO iparm[23]:???? 0 ????????????????? MKL_PARDISO iparm[24]:???? 0 ????????????????? MKL_PARDISO iparm[25]:???? 0 ????????????????? MKL_PARDISO iparm[26]:???? 0 ????????????????? MKL_PARDISO iparm[27]:???? 0 ????????????????? MKL_PARDISO iparm[28]:???? 0 ????????????????? MKL_PARDISO iparm[29]:???? 0 ????????????????? MKL_PARDISO iparm[30]:???? 0 ????????????????? MKL_PARDISO iparm[31]:???? 0 ????????????????? MKL_PARDISO iparm[32]:???? 0 ????????????????? MKL_PARDISO iparm[33]:???? 0 ????????????????? MKL_PARDISO iparm[34]:???? -1 ????????????????? MKL_PARDISO iparm[35]:???? 1 ????????????????? MKL_PARDISO iparm[36]:???? 0 ????????????????? MKL_PARDISO iparm[37]:???? 0 ????????????????? MKL_PARDISO iparm[38]:???? 0 ????????????????? MKL_PARDISO iparm[39]:???? 0 ????????????????? MKL_PARDISO iparm[40]:???? 0 ????????????????? MKL_PARDISO iparm[41]:???? 0 ????????????????? MKL_PARDISO iparm[42]:???? 0 ????????????????? MKL_PARDISO iparm[43]:???? 0 ????????????????? MKL_PARDISO iparm[44]:???? 0 ????????????????? MKL_PARDISO iparm[45]:???? 0 ????????????????? MKL_PARDISO iparm[46]:???? 0 ????????????????? MKL_PARDISO iparm[47]:???? 0 ????????????????? MKL_PARDISO iparm[48]:???? 0 ????????????????? MKL_PARDISO iparm[49]:???? 0 ????????????????? MKL_PARDISO iparm[50]:???? 0 ????????????????? MKL_PARDISO iparm[51]:???? 0 ????????????????? MKL_PARDISO iparm[52]:???? 0 ????????????????? MKL_PARDISO iparm[53]:???? 0 ????????????????? MKL_PARDISO iparm[54]:???? 0 ????????????????? MKL_PARDISO iparm[55]:???? 0 ????????????????? MKL_PARDISO iparm[56]:???? 0 ????????????????? MKL_PARDISO iparm[57]:???? -1 ????????????????? MKL_PARDISO iparm[58]:???? 0 ????????????????? MKL_PARDISO iparm[59]:???? 0 ????????????????? MKL_PARDISO iparm[60]:???? 0 ????????????????? MKL_PARDISO iparm[61]:???? 144 ????????????????? MKL_PARDISO iparm[62]:???? 145 ????????????????? MKL_PARDISO iparm[63]:???? 21 ????????????????? MKL_PARDISO iparm[64]:???? 0 ????????????????? MKL_PARDISO maxfct:???? 1 ????????????????? MKL_PARDISO mnum:???? 1 ????????????????? MKL_PARDISO mtype:???? 11 ????????????????? MKL_PARDISO n:???? 6 ????????????????? MKL_PARDISO nrhs:???? 1 ????????????????? MKL_PARDISO msglvl:???? 0 ??????? linear system matrix = precond matrix: ??????? Mat Object: 1 MPI processes ????????? type: seqaij ????????? rows=6, cols=6 ????????? total: nonzeros=26, allocated nonzeros=26 ????????? total number of mallocs used during MatSetValues calls =0 ??????????? using I-node routines: found 4 nodes, limit used is 5 ??? linear system matrix = precond matrix: ??? Mat Object: 1 MPI processes ????? type: seqaij ????? rows=108000, cols=108000 ????? total: nonzeros=2868000, allocated nonzeros=8640000 ????? total number of mallocs used during MatSetValues calls =0 ??????? not using I-node routines ************************************************************************************************************************ ***???????????? WIDEN YOUR WINDOW TO 120 CHARACTERS.? Use 'enscript -r -fCourier9' to print this document??????????? *** ************************************************************************************************************************ ---------------------------------------------- PETSc Performance Summary: ---------------------------------------------- E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a? named ALIREZA-PC with 1 processor, by AliReza Tue Aug 28 13:57:09 2018 Using Petsc Development GIT revision: v3.9.3-1238-gce82fdcfd6? GIT Date: 2018-08-27 15:47:19 -0500 ???????????????????????? Max?????? Max/Min???? Avg?????? Total Time (sec):?????????? 1.353e+02???? 1.000?? 1.353e+02 Objects:????????????? 1.980e+05???? 1.000?? 1.980e+05 Flop:???????????????? 2.867e+07???? 1.000?? 2.867e+07? 2.867e+07 Flop/sec:???????????? 2.119e+05???? 1.000?? 2.119e+05? 2.119e+05 MPI Messages:???????? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 MPI Message Lengths:? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 MPI Reductions:?????? 0.000e+00???? 0.000 Flop counting convention: 1 flop = 1 real number operation of type (multiply/divide/add/subtract) ??????????????????????????? e.g., VecAXPY() for real vectors of length N --> 2N flop ??????????????????????????? and VecAXPY() for complex vectors of length N --> 8N flop Summary of Stages:?? ----- Time ------? ----- Flop ------? --- Messages ---? -- Message Lengths --? -- Reductions -- ??????????????????????? Avg???? %Total???? Avg???? %Total??? Count %Total???? Avg???????? %Total??? Count?? %Total ?0:????? Main Stage: 1.3529e+02 100.0%? 2.8668e+07 100.0% 0.000e+00?? 0.0%? 0.000e+00??????? 0.0%? 0.000e+00?? 0.0% ------------------------------------------------------------------------------------------------------------------------ See the 'Profiling' chapter of the users' manual for details on interpreting output. Phase summary info: ?? Count: number of times phase was executed ?? Time and Flop: Max - maximum over all processors ????????????????? Ratio - ratio of maximum to minimum over all processors ?? Mess: number of messages sent ?? AvgLen: average message length (bytes) ?? Reduct: number of global reductions ?? Global: entire computation ?? Stage: stages of a computation. Set stages with PetscLogStagePush() and PetscLogStagePop(). ????? %T - percent time in this phase???????? %F - percent flop in this phase ????? %M - percent messages in this phase???? %L - percent message lengths in this phase ????? %R - percent reductions in this phase ?? Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time over all processors) ------------------------------------------------------------------------------------------------------------------------ Event??????????????? Count????? Time (sec) Flop????????????????????????????? --- Global ---? --- Stage ---- Total ?????????????????? Max Ratio? Max???? Ratio?? Max? Ratio? Mess AvgLen? Reduct? %T %F %M %L %R? %T %F %M %L %R Mflop/s ------------------------------------------------------------------------------------------------------------------------ --- Event Stage 0: Main Stage BuildTwoSidedF???????? 2 1.0 1.2701e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 SNESSolve????????????? 1 1.0 1.1583e+02 1.0 2.87e+07 1.0 0.0e+00 0.0e+00 0.0e+00 86100? 0? 0? 0? 86100? 0? 0? 0???? 0 SNESFunctionEval?????? 2 1.0 5.4101e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 SNESJacobianEval?????? 1 1.0 9.3770e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 69? 0? 0? 0? 0? 69? 0? 0? 0? 0???? 0 SNESLineSearch???????? 1 1.0 3.1033e+00 1.0 6.82e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 2 24? 0? 0? 0?? 2 24? 0? 0? 0???? 2 VecDot???????????????? 1 1.0 1.8688e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0? 1156 VecMDot??????????????? 3 1.0 9.9299e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0? 1305 VecNorm??????????????? 7 1.0 6.0845e-03 1.0 1.51e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0?? 248 VecScale?????????????? 4 1.0 1.4437e+00 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 1? 2? 0? 0? 0?? 1? 2? 0? 0? 0???? 0 VecCopy??????????????? 3 1.0 1.6059e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 VecSet???????????? 90002 1.0 1.3843e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecAXPY??????????????? 1 1.0 3.1733e-01 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0???? 1 VecWAXPY?????????????? 1 1.0 2.2665e-04 1.0 1.08e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0?? 477 VecMAXPY?????????????? 4 1.0 8.6085e-04 1.0 1.94e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 7? 0? 0? 0?? 0? 7? 0? 0? 0? 2258 VecAssemblyBegin?????? 2 1.0 1.6379e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecAssemblyEnd???????? 2 1.0 1.4112e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecReduceArith???????? 2 1.0 3.1304e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 1380 VecReduceComm????????? 1 1.0 2.1382e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecNormalize?????????? 4 1.0 1.4441e+00 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 1? 5? 0? 0? 0?? 1? 5? 0? 0? 0???? 1 MatMult??????????????? 4 1.0 2.0402e-02 1.0 2.25e+07 1.0 0.0e+00 0.0e+00 0.0e+00? 0 79? 0? 0? 0?? 0 79? 0? 0? 0? 1103 MatSolve?????????? 72000 1.0 5.3514e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 MatLUFactorSym???? 18000 1.0 1.9405e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 MatLUFactorNum???? 18000 1.0 1.8373e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatAssemblyBegin?? 18002 1.0 1.0409e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatAssemblyEnd???? 18002 1.0 3.3879e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatGetRowIJ??????? 18000 1.0 3.1819e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatCreateSubMats?????? 1 1.0 3.7015e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatGetOrdering???? 18000 1.0 3.0787e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatZeroEntries???????? 1 1.0 2.7952e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatView??????????????? 3 1.0 2.9153e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 KSPSetUp?????????? 18001 1.0 7.5898e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 KSPSolve?????????????? 1 1.0 1.6244e+01 1.0 2.16e+07 1.0 0.0e+00 0.0e+00 0.0e+00 12 75? 0? 0? 0? 12 75? 0? 0? 0???? 1 KSPGMRESOrthog???????? 3 1.0 8.4669e-02 1.0 2.59e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 9? 0? 0? 0?? 0? 9? 0? 0? 0??? 31 PCSetUp??????????? 18001 1.0 3.3536e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 PCSetUpOnBlocks??????? 1 1.0 2.5973e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 PCApply??????????????? 4 1.0 6.2752e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 5? 0? 0? 0? 0?? 5? 0? 0? 0? 0???? 0 PCApplyOnBlocks??? 72000 1.0 5.9278e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 ------------------------------------------------------------------------------------------------------------------------ Memory usage is given in bytes: Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. Reports information only for process 0. --- Event Stage 0: Main Stage ??????????????? SNES???? 1????????????? 0??????????? 0???? 0. ????????????? DMSNES???? 1????????????? 0??????????? 0???? 0. ????? SNESLineSearch???? 1????????????? 0??????????? 0???? 0. ????????????? Vector 36020????????????? 0??????????? 0???? 0. ????????????? Matrix 36001????????????? 0??????????? 0???? 0. ??? Distributed Mesh???? 2????????????? 0??????????? 0???? 0. ?????????? Index Set 90000????????? 36000???? 29088000???? 0. ?? Star Forest Graph???? 4????????????? 0??????????? 0???? 0. ???? Discrete System???? 2????????????? 0??????????? 0???? 0. ?????? Krylov Solver 18001????????????? 0??????????? 0???? 0. ???? DMKSP interface???? 1????????????? 0??????????? 0???? 0. ????? Preconditioner 18001????????????? 0??????????? 0???? 0. ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. ======================================================================================================================== Average time to get PetscTime(): 1.28294e-07 #PETSc Option Table entries: -ksp_atol 1e-6 -ksp_rtol 1e-5 -snes_rtol 1e-4 -sub_ksp_type preonly -sub_pc_factor_mat_solver_type mkl_pardiso -sub_pc_type lu #End of PETSc Option Table entries Compiled without FORTRAN kernels Compiled with full precision matrices (default) sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 sizeof(PetscScalar) 8 sizeof(PetscInt) 4 Configure options: --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl --with-hypre-incl ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdrive/E/Program_Fi les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int el64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debugging=0 --with-blas -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 -Qopenmp" ----------------------------------------- Libraries compiled on 2018-08-27 22:42:15 on AliReza-PC Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit Using PETSc directory: /home/alireza/PetscGit Using PETSc arch: ----------------------------------------- Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl -O2 -MT -wd4996 -Qopenmp Using Fortran compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp -fpp ----------------------------------------- Using include paths: -I/home/alireza/PetscGit/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include -I/cygdrive/E/hypre-2.11.2/ Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include ----------------------------------------- Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort Using libraries: -L/home/alireza/PetscGit/lib -L/home/alireza/PetscGit/lib -lpetsc /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib /cygdrive/E/Trilinos-master/Bins/lib /ml.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Gdi32.lib User32.lib ?Advapi32.lib Kernel32.lib Ws2_32.lib ----------------------------------------- From knepley at gmail.com Tue Aug 28 05:37:21 2018 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 28 Aug 2018 06:37:21 -0400 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <39cf6b2d-76f8-daac-4634-6d60bcfdec41@cc.iut.ac.ir> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <9DAE7720-48CA-4E9E-9760-6B681951D33B@anl.gov> <39cf6b2d-76f8-daac-4634-6d60bcfdec41@cc.iut.ac.ir> Message-ID: On Tue, Aug 28, 2018 at 5:34 AM Ali Reza Khaz'ali wrote: > > > Actually you do not need my new branch to achieve what you desired. > All you need in your main program is something like > > > > ierr = SNESCreate(PETSC_COMM_WORLD,&snes);CHKERRQ(ierr); > > ierr = SNESGetKSP(snes,&ksp);CHKERRQ(ierr); > > ierr = KSPGetPC(ksp,&pc);CHKERRQ(ierr); > > ierr = PCSetType(pc,PCBJACOBI);CHKERRQ(ierr); > > ierr = PCBJacobiSetTotalBlocks(pc,3,lens);CHKERRQ(ierr); /* here you > set your block sizes to whatever you need */ > > > > Then simply do not call PCBJacobiGetSubKSP() but use the options > database to set the inner solver with -sub_pc_type lu -sub_ksp_type preonly > > > > I have updated the branch to move the PCBJacobiSetTotalBlocks() to > the main program but left the callback in there for setting the inner > solver types (though as I just said you don't need to use the callback > since you can control the solver from the options database). The callback > is needed, if, for example, you wished to use a different solver on > different blocks (which is not your case). > > > > Barry > > > > PETSc developers - do you think we should put the callback > functionality into PETSc? It allows doing things that are otherwise not > doable but is rather ugly (perhaps too specialized)? > > > > > > > > It works! Thanks a lot. Here is log of a 30x30x10 system (18000 blocks, > with GMRes solver). I like to have variable sized block preconditioners > and solvers in PETSc. Their application is more than it may first > appear. If it is possible, I would like to contribute to PETSc code, to > build a variable sized block Jacobi and block ILU(k) at the first step > (If I can, of course). Where can I start? > Okay, the best place to start I think is to make an example which shows what you want to demonstrate. Then we can offer feedback, and if anything should move to the library, we can do that in a subsequent contribution. The best way, I think, to make an example is to fork the PETSc repository on Bitbucket (or Github), add you example code to the relevant directory, such as $PETSC_DIR/src/snes/examples/tutorials It will build with make ex1001 or whatever number you choose, and then you make a Pull Request (there is documentation here: https://bitbucket.org/petsc/petsc/wiki/pull-request-instructions-git). Note there is a Developer's Manual which has things like code structure guidelines. Thanks, Matt > type: newtonls > maximum iterations=2000, maximum function evaluations=2000 > tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 > total number of linear solver iterations=3 > total number of function evaluations=2 > norm schedule ALWAYS > SNESLineSearch Object: 1 MPI processes > type: bt > interpolation: cubic > alpha=1.000000e-04 > maxstep=1.000000e+08, minlambda=1.000000e-12 > tolerances: relative=1.000000e-08, absolute=1.000000e-15, > lambda=1.000000e-08 > maximum iterations=40 > KSP Object: 1 MPI processes > type: gmres > restart=30, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > happy breakdown tolerance 1e-30 > maximum iterations=5000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-06, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: 1 MPI processes > type: bjacobi > number of blocks = 18000 > Local solve is same for all blocks, in the following KSP and PC > objects: > KSP Object: (sub_) 1 MPI processes > type: preonly > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > left preconditioning > using NONE norm type for convergence test > PC Object: (sub_) 1 MPI processes > type: lu > out-of-place factorization > tolerance for zero pivot 2.22045e-14 > matrix ordering: nd > factor fill ratio given 0., needed 0. > Factored matrix follows: > Mat Object: 1 MPI processes > type: mkl_pardiso > rows=6, cols=6 > package used to perform factorization: mkl_pardiso > total: nonzeros=26, allocated nonzeros=26 > total number of mallocs used during MatSetValues calls =0 > MKL_PARDISO run parameters: > MKL_PARDISO phase: 33 > MKL_PARDISO iparm[1]: 1 > MKL_PARDISO iparm[2]: 2 > MKL_PARDISO iparm[3]: 1 > MKL_PARDISO iparm[4]: 0 > MKL_PARDISO iparm[5]: 0 > MKL_PARDISO iparm[6]: 0 > MKL_PARDISO iparm[7]: 0 > MKL_PARDISO iparm[8]: 0 > MKL_PARDISO iparm[9]: 0 > MKL_PARDISO iparm[10]: 13 > MKL_PARDISO iparm[11]: 1 > MKL_PARDISO iparm[12]: 0 > MKL_PARDISO iparm[13]: 1 > MKL_PARDISO iparm[14]: 0 > MKL_PARDISO iparm[15]: 144 > MKL_PARDISO iparm[16]: 144 > MKL_PARDISO iparm[17]: 0 > MKL_PARDISO iparm[18]: 37 > MKL_PARDISO iparm[19]: 0 > MKL_PARDISO iparm[20]: 0 > MKL_PARDISO iparm[21]: 0 > MKL_PARDISO iparm[22]: 0 > MKL_PARDISO iparm[23]: 0 > MKL_PARDISO iparm[24]: 0 > MKL_PARDISO iparm[25]: 0 > MKL_PARDISO iparm[26]: 0 > MKL_PARDISO iparm[27]: 0 > MKL_PARDISO iparm[28]: 0 > MKL_PARDISO iparm[29]: 0 > MKL_PARDISO iparm[30]: 0 > MKL_PARDISO iparm[31]: 0 > MKL_PARDISO iparm[32]: 0 > MKL_PARDISO iparm[33]: 0 > MKL_PARDISO iparm[34]: -1 > MKL_PARDISO iparm[35]: 1 > MKL_PARDISO iparm[36]: 0 > MKL_PARDISO iparm[37]: 0 > MKL_PARDISO iparm[38]: 0 > MKL_PARDISO iparm[39]: 0 > MKL_PARDISO iparm[40]: 0 > MKL_PARDISO iparm[41]: 0 > MKL_PARDISO iparm[42]: 0 > MKL_PARDISO iparm[43]: 0 > MKL_PARDISO iparm[44]: 0 > MKL_PARDISO iparm[45]: 0 > MKL_PARDISO iparm[46]: 0 > MKL_PARDISO iparm[47]: 0 > MKL_PARDISO iparm[48]: 0 > MKL_PARDISO iparm[49]: 0 > MKL_PARDISO iparm[50]: 0 > MKL_PARDISO iparm[51]: 0 > MKL_PARDISO iparm[52]: 0 > MKL_PARDISO iparm[53]: 0 > MKL_PARDISO iparm[54]: 0 > MKL_PARDISO iparm[55]: 0 > MKL_PARDISO iparm[56]: 0 > MKL_PARDISO iparm[57]: -1 > MKL_PARDISO iparm[58]: 0 > MKL_PARDISO iparm[59]: 0 > MKL_PARDISO iparm[60]: 0 > MKL_PARDISO iparm[61]: 144 > MKL_PARDISO iparm[62]: 145 > MKL_PARDISO iparm[63]: 21 > MKL_PARDISO iparm[64]: 0 > MKL_PARDISO maxfct: 1 > MKL_PARDISO mnum: 1 > MKL_PARDISO mtype: 11 > MKL_PARDISO n: 6 > MKL_PARDISO nrhs: 1 > MKL_PARDISO msglvl: 0 > linear system matrix = precond matrix: > Mat Object: 1 MPI processes > type: seqaij > rows=6, cols=6 > total: nonzeros=26, allocated nonzeros=26 > total number of mallocs used during MatSetValues calls =0 > using I-node routines: found 4 nodes, limit used is 5 > linear system matrix = precond matrix: > Mat Object: 1 MPI processes > type: seqaij > rows=108000, cols=108000 > total: nonzeros=2868000, allocated nonzeros=8640000 > total number of mallocs used during MatSetValues calls =0 > not using I-node routines > > ************************************************************************************************************************ > *** WIDEN YOUR WINDOW TO 120 CHARACTERS. Use 'enscript -r > -fCourier9' to print this document *** > > ************************************************************************************************************************ > > ---------------------------------------------- PETSc Performance > Summary: ---------------------------------------------- > > E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe > on a named ALIREZA-PC with 1 processor, by AliReza Tue Aug 28 13:57:09 > 2018 > Using Petsc Development GIT revision: v3.9.3-1238-gce82fdcfd6 GIT Date: > 2018-08-27 15:47:19 -0500 > > Max Max/Min Avg Total > Time (sec): 1.353e+02 1.000 1.353e+02 > Objects: 1.980e+05 1.000 1.980e+05 > Flop: 2.867e+07 1.000 2.867e+07 2.867e+07 > Flop/sec: 2.119e+05 1.000 2.119e+05 2.119e+05 > MPI Messages: 0.000e+00 0.000 0.000e+00 0.000e+00 > MPI Message Lengths: 0.000e+00 0.000 0.000e+00 0.000e+00 > MPI Reductions: 0.000e+00 0.000 > > Flop counting convention: 1 flop = 1 real number operation of type > (multiply/divide/add/subtract) > e.g., VecAXPY() for real vectors of length > N --> 2N flop > and VecAXPY() for complex vectors of length > N --> 8N flop > > Summary of Stages: ----- Time ------ ----- Flop ------ --- Messages > --- -- Message Lengths -- -- Reductions -- > Avg %Total Avg %Total Count > %Total Avg %Total Count %Total > 0: Main Stage: 1.3529e+02 100.0% 2.8668e+07 100.0% 0.000e+00 > 0.0% 0.000e+00 0.0% 0.000e+00 0.0% > > > ------------------------------------------------------------------------------------------------------------------------ > See the 'Profiling' chapter of the users' manual for details on > interpreting output. > Phase summary info: > Count: number of times phase was executed > Time and Flop: Max - maximum over all processors > Ratio - ratio of maximum to minimum over all processors > Mess: number of messages sent > AvgLen: average message length (bytes) > Reduct: number of global reductions > Global: entire computation > Stage: stages of a computation. Set stages with PetscLogStagePush() > and PetscLogStagePop(). > %T - percent time in this phase %F - percent flop in this > phase > %M - percent messages in this phase %L - percent message > lengths in this phase > %R - percent reductions in this phase > Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time > over all processors) > > ------------------------------------------------------------------------------------------------------------------------ > Event Count Time (sec) > Flop --- Global --- --- Stage ---- Total > Max Ratio Max Ratio Max Ratio Mess AvgLen > Reduct %T %F %M %L %R %T %F %M %L %R Mflop/s > > ------------------------------------------------------------------------------------------------------------------------ > > --- Event Stage 0: Main Stage > > BuildTwoSidedF 2 1.0 1.2701e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > SNESSolve 1 1.0 1.1583e+02 1.0 2.87e+07 1.0 0.0e+00 0.0e+00 > 0.0e+00 86100 0 0 0 86100 0 0 0 0 > SNESFunctionEval 2 1.0 5.4101e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 > SNESJacobianEval 1 1.0 9.3770e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 69 0 0 0 0 69 0 0 0 0 0 > SNESLineSearch 1 1.0 3.1033e+00 1.0 6.82e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 2 24 0 0 0 2 24 0 0 0 2 > VecDot 1 1.0 1.8688e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 1 0 0 0 0 1 0 0 0 1156 > VecMDot 3 1.0 9.9299e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 5 0 0 0 0 5 0 0 0 1305 > VecNorm 7 1.0 6.0845e-03 1.0 1.51e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 5 0 0 0 0 5 0 0 0 248 > VecScale 4 1.0 1.4437e+00 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 1 2 0 0 0 1 2 0 0 0 0 > VecCopy 3 1.0 1.6059e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 > VecSet 90002 1.0 1.3843e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecAXPY 1 1.0 3.1733e-01 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 1 0 0 0 0 1 0 0 0 1 > VecWAXPY 1 1.0 2.2665e-04 1.0 1.08e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 477 > VecMAXPY 4 1.0 8.6085e-04 1.0 1.94e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 7 0 0 0 0 7 0 0 0 2258 > VecAssemblyBegin 2 1.0 1.6379e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecAssemblyEnd 2 1.0 1.4112e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecReduceArith 2 1.0 3.1304e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 2 0 0 0 0 2 0 0 0 1380 > VecReduceComm 1 1.0 2.1382e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecNormalize 4 1.0 1.4441e+00 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 1 5 0 0 0 1 5 0 0 0 1 > MatMult 4 1.0 2.0402e-02 1.0 2.25e+07 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 79 0 0 0 0 79 0 0 0 1103 > MatSolve 72000 1.0 5.3514e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 > MatLUFactorSym 18000 1.0 1.9405e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 > MatLUFactorNum 18000 1.0 1.8373e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatAssemblyBegin 18002 1.0 1.0409e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatAssemblyEnd 18002 1.0 3.3879e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatGetRowIJ 18000 1.0 3.1819e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatCreateSubMats 1 1.0 3.7015e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatGetOrdering 18000 1.0 3.0787e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatZeroEntries 1 1.0 2.7952e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatView 3 1.0 2.9153e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > KSPSetUp 18001 1.0 7.5898e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > KSPSolve 1 1.0 1.6244e+01 1.0 2.16e+07 1.0 0.0e+00 0.0e+00 > 0.0e+00 12 75 0 0 0 12 75 0 0 0 1 > KSPGMRESOrthog 3 1.0 8.4669e-02 1.0 2.59e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 9 0 0 0 0 9 0 0 0 31 > PCSetUp 18001 1.0 3.3536e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 2 0 0 0 0 2 0 0 0 0 0 > PCSetUpOnBlocks 1 1.0 2.5973e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 2 0 0 0 0 2 0 0 0 0 0 > PCApply 4 1.0 6.2752e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 5 0 0 0 0 5 0 0 0 0 0 > PCApplyOnBlocks 72000 1.0 5.9278e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 > > ------------------------------------------------------------------------------------------------------------------------ > > Memory usage is given in bytes: > > Object Type Creations Destructions Memory Descendants' Mem. > Reports information only for process 0. > > --- Event Stage 0: Main Stage > > SNES 1 0 0 0. > DMSNES 1 0 0 0. > SNESLineSearch 1 0 0 0. > Vector 36020 0 0 0. > Matrix 36001 0 0 0. > Distributed Mesh 2 0 0 0. > Index Set 90000 36000 29088000 0. > Star Forest Graph 4 0 0 0. > Discrete System 2 0 0 0. > Krylov Solver 18001 0 0 0. > DMKSP interface 1 0 0 0. > Preconditioner 18001 0 0 0. > Viewer 1 0 0 0. > > ======================================================================================================================== > Average time to get PetscTime(): 1.28294e-07 > #PETSc Option Table entries: > -ksp_atol 1e-6 > -ksp_rtol 1e-5 > -snes_rtol 1e-4 > -sub_ksp_type preonly > -sub_pc_factor_mat_solver_type mkl_pardiso > -sub_pc_type lu > #End of PETSc Option Table entries > Compiled without FORTRAN kernels > Compiled with full precision matrices (default) > sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 > sizeof(PetscScalar) 8 sizeof(PetscInt) 4 > Configure options: --prefix=/home/alireza/PetscGit > --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl > > --with-hypre-incl > ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include > --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib > --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in > clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib > ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" > --with-mpi-include=/cygdrive/E/Program_Fi > les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include > > --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int > el64/lib/impi.lib > --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe > > --with-debugging=0 --with-blas > -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > > --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool > s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" > -FFLAGS="-MT -O2 -Qopenmp" > ----------------------------------------- > Libraries compiled on 2018-08-27 22:42:15 on AliReza-PC > Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit > Using PETSc directory: /home/alireza/PetscGit > Using PETSc arch: > ----------------------------------------- > > Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl > -O2 -MT -wd4996 -Qopenmp > Using Fortran compiler: > /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp > -fpp > ----------------------------------------- > > Using include paths: -I/home/alireza/PetscGit/include > -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include > > -I/cygdrive/E/hypre-2.11.2/ > Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include > > -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include > ----------------------------------------- > > Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl > Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe > ifort > Using libraries: -L/home/alireza/PetscGit/lib > -L/home/alireza/PetscGit/lib -lpetsc > /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib > /cygdrive/E/Trilinos-master/Bins/lib > /ml.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and > _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib > > Gdi32.lib User32.lib > Advapi32.lib Kernel32.lib Ws2_32.lib > ----------------------------------------- > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From adenchfi at hawk.iit.edu Tue Aug 28 09:04:06 2018 From: adenchfi at hawk.iit.edu (Adam Denchfield) Date: Tue, 28 Aug 2018 09:04:06 -0500 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <9DAE7720-48CA-4E9E-9760-6B681951D33B@anl.gov> <39cf6b2d-76f8-daac-4634-6d60bcfdec41@cc.iut.ac.ir> Message-ID: " PETSc developers - do you think we should put the callback functionality into PETSc? It allows doing things that are otherwise not doable but is rather ugly (perhaps too specialized)?" Though I only worked on it over the summer, the functionality you describe (using different solvers on different blocks) sounds useful to me. Quantum mechanics applications sometimes produce block matrices where the blocks have significantly different structure. On Tue, Aug 28, 2018, 5:37 AM Matthew Knepley wrote: > On Tue, Aug 28, 2018 at 5:34 AM Ali Reza Khaz'ali > wrote: > >> >> > Actually you do not need my new branch to achieve what you desired. >> All you need in your main program is something like >> > >> > ierr = SNESCreate(PETSC_COMM_WORLD,&snes);CHKERRQ(ierr); >> > ierr = SNESGetKSP(snes,&ksp);CHKERRQ(ierr); >> > ierr = KSPGetPC(ksp,&pc);CHKERRQ(ierr); >> > ierr = PCSetType(pc,PCBJACOBI);CHKERRQ(ierr); >> > ierr = PCBJacobiSetTotalBlocks(pc,3,lens);CHKERRQ(ierr); /* here >> you set your block sizes to whatever you need */ >> > >> > Then simply do not call PCBJacobiGetSubKSP() but use the options >> database to set the inner solver with -sub_pc_type lu -sub_ksp_type preonly >> > >> > I have updated the branch to move the PCBJacobiSetTotalBlocks() to >> the main program but left the callback in there for setting the inner >> solver types (though as I just said you don't need to use the callback >> since you can control the solver from the options database). The callback >> is needed, if, for example, you wished to use a different solver on >> different blocks (which is not your case). >> > >> > Barry >> > >> > PETSc developers - do you think we should put the callback >> functionality into PETSc? It allows doing things that are otherwise not >> doable but is rather ugly (perhaps too specialized)? >> > >> > >> > >> >> It works! Thanks a lot. Here is log of a 30x30x10 system (18000 blocks, >> with GMRes solver). I like to have variable sized block preconditioners >> and solvers in PETSc. Their application is more than it may first >> appear. If it is possible, I would like to contribute to PETSc code, to >> build a variable sized block Jacobi and block ILU(k) at the first step >> (If I can, of course). Where can I start? >> > > Okay, the best place to start I think is to make an example which shows > what you want > to demonstrate. Then we can offer feedback, and if anything should move to > the library, > we can do that in a subsequent contribution. > > The best way, I think, to make an example is to fork the PETSc repository > on Bitbucket > (or Github), add you example code to the relevant directory, such as > > $PETSC_DIR/src/snes/examples/tutorials > > It will build with > > make ex1001 > > or whatever number you choose, and then you make a Pull Request (there is > documentation > here: https://bitbucket.org/petsc/petsc/wiki/pull-request-instructions-git). > Note there is a > Developer's Manual which has things like code structure guidelines. > > Thanks, > > Matt > > >> type: newtonls >> maximum iterations=2000, maximum function evaluations=2000 >> tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 >> total number of linear solver iterations=3 >> total number of function evaluations=2 >> norm schedule ALWAYS >> SNESLineSearch Object: 1 MPI processes >> type: bt >> interpolation: cubic >> alpha=1.000000e-04 >> maxstep=1.000000e+08, minlambda=1.000000e-12 >> tolerances: relative=1.000000e-08, absolute=1.000000e-15, >> lambda=1.000000e-08 >> maximum iterations=40 >> KSP Object: 1 MPI processes >> type: gmres >> restart=30, using Classical (unmodified) Gram-Schmidt >> Orthogonalization with no iterative refinement >> happy breakdown tolerance 1e-30 >> maximum iterations=5000, initial guess is zero >> tolerances: relative=1e-05, absolute=1e-06, divergence=10000. >> left preconditioning >> using PRECONDITIONED norm type for convergence test >> PC Object: 1 MPI processes >> type: bjacobi >> number of blocks = 18000 >> Local solve is same for all blocks, in the following KSP and PC >> objects: >> KSP Object: (sub_) 1 MPI processes >> type: preonly >> maximum iterations=10000, initial guess is zero >> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. >> left preconditioning >> using NONE norm type for convergence test >> PC Object: (sub_) 1 MPI processes >> type: lu >> out-of-place factorization >> tolerance for zero pivot 2.22045e-14 >> matrix ordering: nd >> factor fill ratio given 0., needed 0. >> Factored matrix follows: >> Mat Object: 1 MPI processes >> type: mkl_pardiso >> rows=6, cols=6 >> package used to perform factorization: mkl_pardiso >> total: nonzeros=26, allocated nonzeros=26 >> total number of mallocs used during MatSetValues calls =0 >> MKL_PARDISO run parameters: >> MKL_PARDISO phase: 33 >> MKL_PARDISO iparm[1]: 1 >> MKL_PARDISO iparm[2]: 2 >> MKL_PARDISO iparm[3]: 1 >> MKL_PARDISO iparm[4]: 0 >> MKL_PARDISO iparm[5]: 0 >> MKL_PARDISO iparm[6]: 0 >> MKL_PARDISO iparm[7]: 0 >> MKL_PARDISO iparm[8]: 0 >> MKL_PARDISO iparm[9]: 0 >> MKL_PARDISO iparm[10]: 13 >> MKL_PARDISO iparm[11]: 1 >> MKL_PARDISO iparm[12]: 0 >> MKL_PARDISO iparm[13]: 1 >> MKL_PARDISO iparm[14]: 0 >> MKL_PARDISO iparm[15]: 144 >> MKL_PARDISO iparm[16]: 144 >> MKL_PARDISO iparm[17]: 0 >> MKL_PARDISO iparm[18]: 37 >> MKL_PARDISO iparm[19]: 0 >> MKL_PARDISO iparm[20]: 0 >> MKL_PARDISO iparm[21]: 0 >> MKL_PARDISO iparm[22]: 0 >> MKL_PARDISO iparm[23]: 0 >> MKL_PARDISO iparm[24]: 0 >> MKL_PARDISO iparm[25]: 0 >> MKL_PARDISO iparm[26]: 0 >> MKL_PARDISO iparm[27]: 0 >> MKL_PARDISO iparm[28]: 0 >> MKL_PARDISO iparm[29]: 0 >> MKL_PARDISO iparm[30]: 0 >> MKL_PARDISO iparm[31]: 0 >> MKL_PARDISO iparm[32]: 0 >> MKL_PARDISO iparm[33]: 0 >> MKL_PARDISO iparm[34]: -1 >> MKL_PARDISO iparm[35]: 1 >> MKL_PARDISO iparm[36]: 0 >> MKL_PARDISO iparm[37]: 0 >> MKL_PARDISO iparm[38]: 0 >> MKL_PARDISO iparm[39]: 0 >> MKL_PARDISO iparm[40]: 0 >> MKL_PARDISO iparm[41]: 0 >> MKL_PARDISO iparm[42]: 0 >> MKL_PARDISO iparm[43]: 0 >> MKL_PARDISO iparm[44]: 0 >> MKL_PARDISO iparm[45]: 0 >> MKL_PARDISO iparm[46]: 0 >> MKL_PARDISO iparm[47]: 0 >> MKL_PARDISO iparm[48]: 0 >> MKL_PARDISO iparm[49]: 0 >> MKL_PARDISO iparm[50]: 0 >> MKL_PARDISO iparm[51]: 0 >> MKL_PARDISO iparm[52]: 0 >> MKL_PARDISO iparm[53]: 0 >> MKL_PARDISO iparm[54]: 0 >> MKL_PARDISO iparm[55]: 0 >> MKL_PARDISO iparm[56]: 0 >> MKL_PARDISO iparm[57]: -1 >> MKL_PARDISO iparm[58]: 0 >> MKL_PARDISO iparm[59]: 0 >> MKL_PARDISO iparm[60]: 0 >> MKL_PARDISO iparm[61]: 144 >> MKL_PARDISO iparm[62]: 145 >> MKL_PARDISO iparm[63]: 21 >> MKL_PARDISO iparm[64]: 0 >> MKL_PARDISO maxfct: 1 >> MKL_PARDISO mnum: 1 >> MKL_PARDISO mtype: 11 >> MKL_PARDISO n: 6 >> MKL_PARDISO nrhs: 1 >> MKL_PARDISO msglvl: 0 >> linear system matrix = precond matrix: >> Mat Object: 1 MPI processes >> type: seqaij >> rows=6, cols=6 >> total: nonzeros=26, allocated nonzeros=26 >> total number of mallocs used during MatSetValues calls =0 >> using I-node routines: found 4 nodes, limit used is 5 >> linear system matrix = precond matrix: >> Mat Object: 1 MPI processes >> type: seqaij >> rows=108000, cols=108000 >> total: nonzeros=2868000, allocated nonzeros=8640000 >> total number of mallocs used during MatSetValues calls =0 >> not using I-node routines >> >> ************************************************************************************************************************ >> *** WIDEN YOUR WINDOW TO 120 CHARACTERS. Use 'enscript -r >> -fCourier9' to print this document *** >> >> ************************************************************************************************************************ >> >> ---------------------------------------------- PETSc Performance >> Summary: ---------------------------------------------- >> >> E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe >> on a named ALIREZA-PC with 1 processor, by AliReza Tue Aug 28 13:57:09 >> 2018 >> Using Petsc Development GIT revision: v3.9.3-1238-gce82fdcfd6 GIT Date: >> 2018-08-27 15:47:19 -0500 >> >> Max Max/Min Avg Total >> Time (sec): 1.353e+02 1.000 1.353e+02 >> Objects: 1.980e+05 1.000 1.980e+05 >> Flop: 2.867e+07 1.000 2.867e+07 2.867e+07 >> Flop/sec: 2.119e+05 1.000 2.119e+05 2.119e+05 >> MPI Messages: 0.000e+00 0.000 0.000e+00 0.000e+00 >> MPI Message Lengths: 0.000e+00 0.000 0.000e+00 0.000e+00 >> MPI Reductions: 0.000e+00 0.000 >> >> Flop counting convention: 1 flop = 1 real number operation of type >> (multiply/divide/add/subtract) >> e.g., VecAXPY() for real vectors of length >> N --> 2N flop >> and VecAXPY() for complex vectors of length >> N --> 8N flop >> >> Summary of Stages: ----- Time ------ ----- Flop ------ --- Messages >> --- -- Message Lengths -- -- Reductions -- >> Avg %Total Avg %Total Count >> %Total Avg %Total Count %Total >> 0: Main Stage: 1.3529e+02 100.0% 2.8668e+07 100.0% 0.000e+00 >> 0.0% 0.000e+00 0.0% 0.000e+00 0.0% >> >> >> ------------------------------------------------------------------------------------------------------------------------ >> See the 'Profiling' chapter of the users' manual for details on >> interpreting output. >> Phase summary info: >> Count: number of times phase was executed >> Time and Flop: Max - maximum over all processors >> Ratio - ratio of maximum to minimum over all processors >> Mess: number of messages sent >> AvgLen: average message length (bytes) >> Reduct: number of global reductions >> Global: entire computation >> Stage: stages of a computation. Set stages with PetscLogStagePush() >> and PetscLogStagePop(). >> %T - percent time in this phase %F - percent flop in this >> phase >> %M - percent messages in this phase %L - percent message >> lengths in this phase >> %R - percent reductions in this phase >> Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time >> over all processors) >> >> ------------------------------------------------------------------------------------------------------------------------ >> Event Count Time (sec) >> Flop --- Global --- --- Stage ---- Total >> Max Ratio Max Ratio Max Ratio Mess AvgLen >> Reduct %T %F %M %L %R %T %F %M %L %R Mflop/s >> >> ------------------------------------------------------------------------------------------------------------------------ >> >> --- Event Stage 0: Main Stage >> >> BuildTwoSidedF 2 1.0 1.2701e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> SNESSolve 1 1.0 1.1583e+02 1.0 2.87e+07 1.0 0.0e+00 0.0e+00 >> 0.0e+00 86100 0 0 0 86100 0 0 0 0 >> SNESFunctionEval 2 1.0 5.4101e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 >> SNESJacobianEval 1 1.0 9.3770e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 69 0 0 0 0 69 0 0 0 0 0 >> SNESLineSearch 1 1.0 3.1033e+00 1.0 6.82e+06 1.0 0.0e+00 0.0e+00 >> 0.0e+00 2 24 0 0 0 2 24 0 0 0 2 >> VecDot 1 1.0 1.8688e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 >> 0.0e+00 0 1 0 0 0 0 1 0 0 0 1156 >> VecMDot 3 1.0 9.9299e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 >> 0.0e+00 0 5 0 0 0 0 5 0 0 0 1305 >> VecNorm 7 1.0 6.0845e-03 1.0 1.51e+06 1.0 0.0e+00 0.0e+00 >> 0.0e+00 0 5 0 0 0 0 5 0 0 0 248 >> VecScale 4 1.0 1.4437e+00 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 >> 0.0e+00 1 2 0 0 0 1 2 0 0 0 0 >> VecCopy 3 1.0 1.6059e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 >> VecSet 90002 1.0 1.3843e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> VecAXPY 1 1.0 3.1733e-01 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 >> 0.0e+00 0 1 0 0 0 0 1 0 0 0 1 >> VecWAXPY 1 1.0 2.2665e-04 1.0 1.08e+05 1.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 477 >> VecMAXPY 4 1.0 8.6085e-04 1.0 1.94e+06 1.0 0.0e+00 0.0e+00 >> 0.0e+00 0 7 0 0 0 0 7 0 0 0 2258 >> VecAssemblyBegin 2 1.0 1.6379e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> VecAssemblyEnd 2 1.0 1.4112e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> VecReduceArith 2 1.0 3.1304e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 >> 0.0e+00 0 2 0 0 0 0 2 0 0 0 1380 >> VecReduceComm 1 1.0 2.1382e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> VecNormalize 4 1.0 1.4441e+00 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 >> 0.0e+00 1 5 0 0 0 1 5 0 0 0 1 >> MatMult 4 1.0 2.0402e-02 1.0 2.25e+07 1.0 0.0e+00 0.0e+00 >> 0.0e+00 0 79 0 0 0 0 79 0 0 0 1103 >> MatSolve 72000 1.0 5.3514e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 >> MatLUFactorSym 18000 1.0 1.9405e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 >> MatLUFactorNum 18000 1.0 1.8373e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> MatAssemblyBegin 18002 1.0 1.0409e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> MatAssemblyEnd 18002 1.0 3.3879e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> MatGetRowIJ 18000 1.0 3.1819e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> MatCreateSubMats 1 1.0 3.7015e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> MatGetOrdering 18000 1.0 3.0787e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> MatZeroEntries 1 1.0 2.7952e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> MatView 3 1.0 2.9153e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> KSPSetUp 18001 1.0 7.5898e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >> KSPSolve 1 1.0 1.6244e+01 1.0 2.16e+07 1.0 0.0e+00 0.0e+00 >> 0.0e+00 12 75 0 0 0 12 75 0 0 0 1 >> KSPGMRESOrthog 3 1.0 8.4669e-02 1.0 2.59e+06 1.0 0.0e+00 0.0e+00 >> 0.0e+00 0 9 0 0 0 0 9 0 0 0 31 >> PCSetUp 18001 1.0 3.3536e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 2 0 0 0 0 2 0 0 0 0 0 >> PCSetUpOnBlocks 1 1.0 2.5973e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 2 0 0 0 0 2 0 0 0 0 0 >> PCApply 4 1.0 6.2752e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 5 0 0 0 0 5 0 0 0 0 0 >> PCApplyOnBlocks 72000 1.0 5.9278e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 >> >> ------------------------------------------------------------------------------------------------------------------------ >> >> Memory usage is given in bytes: >> >> Object Type Creations Destructions Memory Descendants' Mem. >> Reports information only for process 0. >> >> --- Event Stage 0: Main Stage >> >> SNES 1 0 0 0. >> DMSNES 1 0 0 0. >> SNESLineSearch 1 0 0 0. >> Vector 36020 0 0 0. >> Matrix 36001 0 0 0. >> Distributed Mesh 2 0 0 0. >> Index Set 90000 36000 29088000 0. >> Star Forest Graph 4 0 0 0. >> Discrete System 2 0 0 0. >> Krylov Solver 18001 0 0 0. >> DMKSP interface 1 0 0 0. >> Preconditioner 18001 0 0 0. >> Viewer 1 0 0 0. >> >> ======================================================================================================================== >> Average time to get PetscTime(): 1.28294e-07 >> #PETSc Option Table entries: >> -ksp_atol 1e-6 >> -ksp_rtol 1e-5 >> -snes_rtol 1e-4 >> -sub_ksp_type preonly >> -sub_pc_factor_mat_solver_type mkl_pardiso >> -sub_pc_type lu >> #End of PETSc Option Table entries >> Compiled without FORTRAN kernels >> Compiled with full precision matrices (default) >> sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 >> sizeof(PetscScalar) 8 sizeof(PetscInt) 4 >> Configure options: --prefix=/home/alireza/PetscGit >> --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl >> >> --with-hypre-incl >> ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include >> --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >> --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in >> clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib >> ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" >> --with-mpi-include=/cygdrive/E/Program_Fi >> les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >> >> --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int >> el64/lib/impi.lib >> --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe >> >> --with-debugging=0 --with-blas >> -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> >> --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool >> s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" >> -FFLAGS="-MT -O2 -Qopenmp" >> ----------------------------------------- >> Libraries compiled on 2018-08-27 22:42:15 on AliReza-PC >> Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit >> Using PETSc directory: /home/alireza/PetscGit >> Using PETSc arch: >> ----------------------------------------- >> >> Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >> -O2 -MT -wd4996 -Qopenmp >> Using Fortran compiler: >> /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp >> -fpp >> ----------------------------------------- >> >> Using include paths: -I/home/alireza/PetscGit/include >> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include >> >> -I/cygdrive/E/hypre-2.11.2/ >> Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include >> >> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >> ----------------------------------------- >> >> Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >> Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe >> ifort >> Using libraries: -L/home/alireza/PetscGit/lib >> -L/home/alireza/PetscGit/lib -lpetsc >> /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >> /cygdrive/E/Trilinos-master/Bins/lib >> /ml.lib >> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> >> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and >> _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib >> >> Gdi32.lib User32.lib >> Advapi32.lib Kernel32.lib Ws2_32.lib >> ----------------------------------------- >> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Tue Aug 28 12:32:10 2018 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 28 Aug 2018 13:32:10 -0400 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <9DAE7720-48CA-4E9E-9760-6B681951D33B@anl.gov> <39cf6b2d-76f8-daac-4634-6d60bcfdec41@cc.iut.ac.ir> Message-ID: On Tue, Aug 28, 2018 at 10:04 AM Adam Denchfield wrote: > " PETSc developers - do you think we should put the callback > functionality into PETSc? It allows doing things that are otherwise not > doable but is rather ugly (perhaps too specialized)?" > > Though I only worked on it over the summer, the functionality you describe > (using different solvers on different blocks) sounds useful to me. Quantum > mechanics applications sometimes produce block matrices where the blocks > have significantly different structure. > I don't think we need callbacks, you just need to give different prefixes to different blocks. I have done this before. Matt > On Tue, Aug 28, 2018, 5:37 AM Matthew Knepley wrote: > >> On Tue, Aug 28, 2018 at 5:34 AM Ali Reza Khaz'ali >> wrote: >> >>> >>> > Actually you do not need my new branch to achieve what you >>> desired. All you need in your main program is something like >>> > >>> > ierr = SNESCreate(PETSC_COMM_WORLD,&snes);CHKERRQ(ierr); >>> > ierr = SNESGetKSP(snes,&ksp);CHKERRQ(ierr); >>> > ierr = KSPGetPC(ksp,&pc);CHKERRQ(ierr); >>> > ierr = PCSetType(pc,PCBJACOBI);CHKERRQ(ierr); >>> > ierr = PCBJacobiSetTotalBlocks(pc,3,lens);CHKERRQ(ierr); /* here >>> you set your block sizes to whatever you need */ >>> > >>> > Then simply do not call PCBJacobiGetSubKSP() but use the options >>> database to set the inner solver with -sub_pc_type lu -sub_ksp_type preonly >>> > >>> > I have updated the branch to move the PCBJacobiSetTotalBlocks() >>> to the main program but left the callback in there for setting the inner >>> solver types (though as I just said you don't need to use the callback >>> since you can control the solver from the options database). The callback >>> is needed, if, for example, you wished to use a different solver on >>> different blocks (which is not your case). >>> > >>> > Barry >>> > >>> > PETSc developers - do you think we should put the callback >>> functionality into PETSc? It allows doing things that are otherwise not >>> doable but is rather ugly (perhaps too specialized)? >>> > >>> > >>> > >>> >>> It works! Thanks a lot. Here is log of a 30x30x10 system (18000 blocks, >>> with GMRes solver). I like to have variable sized block preconditioners >>> and solvers in PETSc. Their application is more than it may first >>> appear. If it is possible, I would like to contribute to PETSc code, to >>> build a variable sized block Jacobi and block ILU(k) at the first step >>> (If I can, of course). Where can I start? >>> >> >> Okay, the best place to start I think is to make an example which shows >> what you want >> to demonstrate. Then we can offer feedback, and if anything should move >> to the library, >> we can do that in a subsequent contribution. >> >> The best way, I think, to make an example is to fork the PETSc repository >> on Bitbucket >> (or Github), add you example code to the relevant directory, such as >> >> $PETSC_DIR/src/snes/examples/tutorials >> >> It will build with >> >> make ex1001 >> >> or whatever number you choose, and then you make a Pull Request (there is >> documentation >> here: >> https://bitbucket.org/petsc/petsc/wiki/pull-request-instructions-git). >> Note there is a >> Developer's Manual which has things like code structure guidelines. >> >> Thanks, >> >> Matt >> >> >>> type: newtonls >>> maximum iterations=2000, maximum function evaluations=2000 >>> tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 >>> total number of linear solver iterations=3 >>> total number of function evaluations=2 >>> norm schedule ALWAYS >>> SNESLineSearch Object: 1 MPI processes >>> type: bt >>> interpolation: cubic >>> alpha=1.000000e-04 >>> maxstep=1.000000e+08, minlambda=1.000000e-12 >>> tolerances: relative=1.000000e-08, absolute=1.000000e-15, >>> lambda=1.000000e-08 >>> maximum iterations=40 >>> KSP Object: 1 MPI processes >>> type: gmres >>> restart=30, using Classical (unmodified) Gram-Schmidt >>> Orthogonalization with no iterative refinement >>> happy breakdown tolerance 1e-30 >>> maximum iterations=5000, initial guess is zero >>> tolerances: relative=1e-05, absolute=1e-06, divergence=10000. >>> left preconditioning >>> using PRECONDITIONED norm type for convergence test >>> PC Object: 1 MPI processes >>> type: bjacobi >>> number of blocks = 18000 >>> Local solve is same for all blocks, in the following KSP and PC >>> objects: >>> KSP Object: (sub_) 1 MPI processes >>> type: preonly >>> maximum iterations=10000, initial guess is zero >>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. >>> left preconditioning >>> using NONE norm type for convergence test >>> PC Object: (sub_) 1 MPI processes >>> type: lu >>> out-of-place factorization >>> tolerance for zero pivot 2.22045e-14 >>> matrix ordering: nd >>> factor fill ratio given 0., needed 0. >>> Factored matrix follows: >>> Mat Object: 1 MPI processes >>> type: mkl_pardiso >>> rows=6, cols=6 >>> package used to perform factorization: mkl_pardiso >>> total: nonzeros=26, allocated nonzeros=26 >>> total number of mallocs used during MatSetValues calls >>> =0 >>> MKL_PARDISO run parameters: >>> MKL_PARDISO phase: 33 >>> MKL_PARDISO iparm[1]: 1 >>> MKL_PARDISO iparm[2]: 2 >>> MKL_PARDISO iparm[3]: 1 >>> MKL_PARDISO iparm[4]: 0 >>> MKL_PARDISO iparm[5]: 0 >>> MKL_PARDISO iparm[6]: 0 >>> MKL_PARDISO iparm[7]: 0 >>> MKL_PARDISO iparm[8]: 0 >>> MKL_PARDISO iparm[9]: 0 >>> MKL_PARDISO iparm[10]: 13 >>> MKL_PARDISO iparm[11]: 1 >>> MKL_PARDISO iparm[12]: 0 >>> MKL_PARDISO iparm[13]: 1 >>> MKL_PARDISO iparm[14]: 0 >>> MKL_PARDISO iparm[15]: 144 >>> MKL_PARDISO iparm[16]: 144 >>> MKL_PARDISO iparm[17]: 0 >>> MKL_PARDISO iparm[18]: 37 >>> MKL_PARDISO iparm[19]: 0 >>> MKL_PARDISO iparm[20]: 0 >>> MKL_PARDISO iparm[21]: 0 >>> MKL_PARDISO iparm[22]: 0 >>> MKL_PARDISO iparm[23]: 0 >>> MKL_PARDISO iparm[24]: 0 >>> MKL_PARDISO iparm[25]: 0 >>> MKL_PARDISO iparm[26]: 0 >>> MKL_PARDISO iparm[27]: 0 >>> MKL_PARDISO iparm[28]: 0 >>> MKL_PARDISO iparm[29]: 0 >>> MKL_PARDISO iparm[30]: 0 >>> MKL_PARDISO iparm[31]: 0 >>> MKL_PARDISO iparm[32]: 0 >>> MKL_PARDISO iparm[33]: 0 >>> MKL_PARDISO iparm[34]: -1 >>> MKL_PARDISO iparm[35]: 1 >>> MKL_PARDISO iparm[36]: 0 >>> MKL_PARDISO iparm[37]: 0 >>> MKL_PARDISO iparm[38]: 0 >>> MKL_PARDISO iparm[39]: 0 >>> MKL_PARDISO iparm[40]: 0 >>> MKL_PARDISO iparm[41]: 0 >>> MKL_PARDISO iparm[42]: 0 >>> MKL_PARDISO iparm[43]: 0 >>> MKL_PARDISO iparm[44]: 0 >>> MKL_PARDISO iparm[45]: 0 >>> MKL_PARDISO iparm[46]: 0 >>> MKL_PARDISO iparm[47]: 0 >>> MKL_PARDISO iparm[48]: 0 >>> MKL_PARDISO iparm[49]: 0 >>> MKL_PARDISO iparm[50]: 0 >>> MKL_PARDISO iparm[51]: 0 >>> MKL_PARDISO iparm[52]: 0 >>> MKL_PARDISO iparm[53]: 0 >>> MKL_PARDISO iparm[54]: 0 >>> MKL_PARDISO iparm[55]: 0 >>> MKL_PARDISO iparm[56]: 0 >>> MKL_PARDISO iparm[57]: -1 >>> MKL_PARDISO iparm[58]: 0 >>> MKL_PARDISO iparm[59]: 0 >>> MKL_PARDISO iparm[60]: 0 >>> MKL_PARDISO iparm[61]: 144 >>> MKL_PARDISO iparm[62]: 145 >>> MKL_PARDISO iparm[63]: 21 >>> MKL_PARDISO iparm[64]: 0 >>> MKL_PARDISO maxfct: 1 >>> MKL_PARDISO mnum: 1 >>> MKL_PARDISO mtype: 11 >>> MKL_PARDISO n: 6 >>> MKL_PARDISO nrhs: 1 >>> MKL_PARDISO msglvl: 0 >>> linear system matrix = precond matrix: >>> Mat Object: 1 MPI processes >>> type: seqaij >>> rows=6, cols=6 >>> total: nonzeros=26, allocated nonzeros=26 >>> total number of mallocs used during MatSetValues calls =0 >>> using I-node routines: found 4 nodes, limit used is 5 >>> linear system matrix = precond matrix: >>> Mat Object: 1 MPI processes >>> type: seqaij >>> rows=108000, cols=108000 >>> total: nonzeros=2868000, allocated nonzeros=8640000 >>> total number of mallocs used during MatSetValues calls =0 >>> not using I-node routines >>> >>> ************************************************************************************************************************ >>> *** WIDEN YOUR WINDOW TO 120 CHARACTERS. Use 'enscript -r >>> -fCourier9' to print this document *** >>> >>> ************************************************************************************************************************ >>> >>> ---------------------------------------------- PETSc Performance >>> Summary: ---------------------------------------------- >>> >>> E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe >>> on a named ALIREZA-PC with 1 processor, by AliReza Tue Aug 28 13:57:09 >>> 2018 >>> Using Petsc Development GIT revision: v3.9.3-1238-gce82fdcfd6 GIT Date: >>> 2018-08-27 15:47:19 -0500 >>> >>> Max Max/Min Avg Total >>> Time (sec): 1.353e+02 1.000 1.353e+02 >>> Objects: 1.980e+05 1.000 1.980e+05 >>> Flop: 2.867e+07 1.000 2.867e+07 2.867e+07 >>> Flop/sec: 2.119e+05 1.000 2.119e+05 2.119e+05 >>> MPI Messages: 0.000e+00 0.000 0.000e+00 0.000e+00 >>> MPI Message Lengths: 0.000e+00 0.000 0.000e+00 0.000e+00 >>> MPI Reductions: 0.000e+00 0.000 >>> >>> Flop counting convention: 1 flop = 1 real number operation of type >>> (multiply/divide/add/subtract) >>> e.g., VecAXPY() for real vectors of length >>> N --> 2N flop >>> and VecAXPY() for complex vectors of length >>> N --> 8N flop >>> >>> Summary of Stages: ----- Time ------ ----- Flop ------ --- Messages >>> --- -- Message Lengths -- -- Reductions -- >>> Avg %Total Avg %Total Count >>> %Total Avg %Total Count %Total >>> 0: Main Stage: 1.3529e+02 100.0% 2.8668e+07 100.0% 0.000e+00 >>> 0.0% 0.000e+00 0.0% 0.000e+00 0.0% >>> >>> >>> ------------------------------------------------------------------------------------------------------------------------ >>> See the 'Profiling' chapter of the users' manual for details on >>> interpreting output. >>> Phase summary info: >>> Count: number of times phase was executed >>> Time and Flop: Max - maximum over all processors >>> Ratio - ratio of maximum to minimum over all >>> processors >>> Mess: number of messages sent >>> AvgLen: average message length (bytes) >>> Reduct: number of global reductions >>> Global: entire computation >>> Stage: stages of a computation. Set stages with PetscLogStagePush() >>> and PetscLogStagePop(). >>> %T - percent time in this phase %F - percent flop in this >>> phase >>> %M - percent messages in this phase %L - percent message >>> lengths in this phase >>> %R - percent reductions in this phase >>> Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time >>> over all processors) >>> >>> ------------------------------------------------------------------------------------------------------------------------ >>> Event Count Time (sec) >>> Flop --- Global --- --- Stage ---- Total >>> Max Ratio Max Ratio Max Ratio Mess AvgLen >>> Reduct %T %F %M %L %R %T %F %M %L %R Mflop/s >>> >>> ------------------------------------------------------------------------------------------------------------------------ >>> >>> --- Event Stage 0: Main Stage >>> >>> BuildTwoSidedF 2 1.0 1.2701e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> SNESSolve 1 1.0 1.1583e+02 1.0 2.87e+07 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 86100 0 0 0 86100 0 0 0 0 >>> SNESFunctionEval 2 1.0 5.4101e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 >>> SNESJacobianEval 1 1.0 9.3770e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 69 0 0 0 0 69 0 0 0 0 0 >>> SNESLineSearch 1 1.0 3.1033e+00 1.0 6.82e+06 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 2 24 0 0 0 2 24 0 0 0 2 >>> VecDot 1 1.0 1.8688e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 1 0 0 0 0 1 0 0 0 1156 >>> VecMDot 3 1.0 9.9299e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 5 0 0 0 0 5 0 0 0 1305 >>> VecNorm 7 1.0 6.0845e-03 1.0 1.51e+06 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 5 0 0 0 0 5 0 0 0 248 >>> VecScale 4 1.0 1.4437e+00 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 1 2 0 0 0 1 2 0 0 0 0 >>> VecCopy 3 1.0 1.6059e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 >>> VecSet 90002 1.0 1.3843e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> VecAXPY 1 1.0 3.1733e-01 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 1 0 0 0 0 1 0 0 0 1 >>> VecWAXPY 1 1.0 2.2665e-04 1.0 1.08e+05 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 477 >>> VecMAXPY 4 1.0 8.6085e-04 1.0 1.94e+06 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 7 0 0 0 0 7 0 0 0 2258 >>> VecAssemblyBegin 2 1.0 1.6379e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> VecAssemblyEnd 2 1.0 1.4112e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> VecReduceArith 2 1.0 3.1304e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 2 0 0 0 0 2 0 0 0 1380 >>> VecReduceComm 1 1.0 2.1382e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> VecNormalize 4 1.0 1.4441e+00 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 1 5 0 0 0 1 5 0 0 0 1 >>> MatMult 4 1.0 2.0402e-02 1.0 2.25e+07 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 79 0 0 0 0 79 0 0 0 1103 >>> MatSolve 72000 1.0 5.3514e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 >>> MatLUFactorSym 18000 1.0 1.9405e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 >>> MatLUFactorNum 18000 1.0 1.8373e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> MatAssemblyBegin 18002 1.0 1.0409e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> MatAssemblyEnd 18002 1.0 3.3879e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> MatGetRowIJ 18000 1.0 3.1819e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> MatCreateSubMats 1 1.0 3.7015e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> MatGetOrdering 18000 1.0 3.0787e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> MatZeroEntries 1 1.0 2.7952e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> MatView 3 1.0 2.9153e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> KSPSetUp 18001 1.0 7.5898e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>> KSPSolve 1 1.0 1.6244e+01 1.0 2.16e+07 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 12 75 0 0 0 12 75 0 0 0 1 >>> KSPGMRESOrthog 3 1.0 8.4669e-02 1.0 2.59e+06 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 0 9 0 0 0 0 9 0 0 0 31 >>> PCSetUp 18001 1.0 3.3536e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 2 0 0 0 0 2 0 0 0 0 0 >>> PCSetUpOnBlocks 1 1.0 2.5973e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 2 0 0 0 0 2 0 0 0 0 0 >>> PCApply 4 1.0 6.2752e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 5 0 0 0 0 5 0 0 0 0 0 >>> PCApplyOnBlocks 72000 1.0 5.9278e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 >>> >>> ------------------------------------------------------------------------------------------------------------------------ >>> >>> Memory usage is given in bytes: >>> >>> Object Type Creations Destructions Memory Descendants' >>> Mem. >>> Reports information only for process 0. >>> >>> --- Event Stage 0: Main Stage >>> >>> SNES 1 0 0 0. >>> DMSNES 1 0 0 0. >>> SNESLineSearch 1 0 0 0. >>> Vector 36020 0 0 0. >>> Matrix 36001 0 0 0. >>> Distributed Mesh 2 0 0 0. >>> Index Set 90000 36000 29088000 0. >>> Star Forest Graph 4 0 0 0. >>> Discrete System 2 0 0 0. >>> Krylov Solver 18001 0 0 0. >>> DMKSP interface 1 0 0 0. >>> Preconditioner 18001 0 0 0. >>> Viewer 1 0 0 0. >>> >>> ======================================================================================================================== >>> Average time to get PetscTime(): 1.28294e-07 >>> #PETSc Option Table entries: >>> -ksp_atol 1e-6 >>> -ksp_rtol 1e-5 >>> -snes_rtol 1e-4 >>> -sub_ksp_type preonly >>> -sub_pc_factor_mat_solver_type mkl_pardiso >>> -sub_pc_type lu >>> #End of PETSc Option Table entries >>> Compiled without FORTRAN kernels >>> Compiled with full precision matrices (default) >>> sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 >>> sizeof(PetscScalar) 8 sizeof(PetscInt) 4 >>> Configure options: --prefix=/home/alireza/PetscGit >>> --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl >>> >>> --with-hypre-incl >>> ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include >>> --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >>> --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in >>> clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib >>> ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" >>> --with-mpi-include=/cygdrive/E/Program_Fi >>> les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >>> >>> --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int >>> el64/lib/impi.lib >>> --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe >>> >>> --with-debugging=0 --with-blas >>> -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> >>> --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool >>> s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" >>> -FFLAGS="-MT -O2 -Qopenmp" >>> ----------------------------------------- >>> Libraries compiled on 2018-08-27 22:42:15 on AliReza-PC >>> Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit >>> Using PETSc directory: /home/alireza/PetscGit >>> Using PETSc arch: >>> ----------------------------------------- >>> >>> Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >>> -O2 -MT -wd4996 -Qopenmp >>> Using Fortran compiler: >>> /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp >>> -fpp >>> ----------------------------------------- >>> >>> Using include paths: -I/home/alireza/PetscGit/include >>> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include >>> >>> -I/cygdrive/E/hypre-2.11.2/ >>> Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include >>> >>> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >>> ----------------------------------------- >>> >>> Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >>> Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe >>> ifort >>> Using libraries: -L/home/alireza/PetscGit/lib >>> -L/home/alireza/PetscGit/lib -lpetsc >>> /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >>> /cygdrive/E/Trilinos-master/Bins/lib >>> /ml.lib >>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> >>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and >>> _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib >>> >>> Gdi32.lib User32.lib >>> Advapi32.lib Kernel32.lib Ws2_32.lib >>> ----------------------------------------- >>> >>> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> >> > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Aug 28 12:38:18 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Tue, 28 Aug 2018 17:38:18 +0000 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <9DAE7720-48CA-4E9E-9760-6B681951D33B@anl.gov> <39cf6b2d-76f8-daac-4634-6d60bcfdec41@cc.iut.ac.ir> Message-ID: Example? Without the callback I don't think you can access the subblocks at the appropriate time to set their prefixes Barry > On Aug 28, 2018, at 12:32 PM, Matthew Knepley wrote: > > On Tue, Aug 28, 2018 at 10:04 AM Adam Denchfield wrote: > " PETSc developers - do you think we should put the callback functionality into PETSc? It allows doing things that are otherwise not doable but is rather ugly (perhaps too specialized)?" > > Though I only worked on it over the summer, the functionality you describe (using different solvers on different blocks) sounds useful to me. Quantum mechanics applications sometimes produce block matrices where the blocks have significantly different structure. > > I don't think we need callbacks, you just need to give different prefixes to different blocks. I have done this before. > > Matt > > On Tue, Aug 28, 2018, 5:37 AM Matthew Knepley wrote: > On Tue, Aug 28, 2018 at 5:34 AM Ali Reza Khaz'ali wrote: > > > Actually you do not need my new branch to achieve what you desired. All you need in your main program is something like > > > > ierr = SNESCreate(PETSC_COMM_WORLD,&snes);CHKERRQ(ierr); > > ierr = SNESGetKSP(snes,&ksp);CHKERRQ(ierr); > > ierr = KSPGetPC(ksp,&pc);CHKERRQ(ierr); > > ierr = PCSetType(pc,PCBJACOBI);CHKERRQ(ierr); > > ierr = PCBJacobiSetTotalBlocks(pc,3,lens);CHKERRQ(ierr); /* here you set your block sizes to whatever you need */ > > > > Then simply do not call PCBJacobiGetSubKSP() but use the options database to set the inner solver with -sub_pc_type lu -sub_ksp_type preonly > > > > I have updated the branch to move the PCBJacobiSetTotalBlocks() to the main program but left the callback in there for setting the inner solver types (though as I just said you don't need to use the callback since you can control the solver from the options database). The callback is needed, if, for example, you wished to use a different solver on different blocks (which is not your case). > > > > Barry > > > > PETSc developers - do you think we should put the callback functionality into PETSc? It allows doing things that are otherwise not doable but is rather ugly (perhaps too specialized)? > > > > > > > > It works! Thanks a lot. Here is log of a 30x30x10 system (18000 blocks, > with GMRes solver). I like to have variable sized block preconditioners > and solvers in PETSc. Their application is more than it may first > appear. If it is possible, I would like to contribute to PETSc code, to > build a variable sized block Jacobi and block ILU(k) at the first step > (If I can, of course). Where can I start? > > Okay, the best place to start I think is to make an example which shows what you want > to demonstrate. Then we can offer feedback, and if anything should move to the library, > we can do that in a subsequent contribution. > > The best way, I think, to make an example is to fork the PETSc repository on Bitbucket > (or Github), add you example code to the relevant directory, such as > > $PETSC_DIR/src/snes/examples/tutorials > > It will build with > > make ex1001 > > or whatever number you choose, and then you make a Pull Request (there is documentation > here: https://bitbucket.org/petsc/petsc/wiki/pull-request-instructions-git). Note there is a > Developer's Manual which has things like code structure guidelines. > > Thanks, > > Matt > > type: newtonls > maximum iterations=2000, maximum function evaluations=2000 > tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 > total number of linear solver iterations=3 > total number of function evaluations=2 > norm schedule ALWAYS > SNESLineSearch Object: 1 MPI processes > type: bt > interpolation: cubic > alpha=1.000000e-04 > maxstep=1.000000e+08, minlambda=1.000000e-12 > tolerances: relative=1.000000e-08, absolute=1.000000e-15, > lambda=1.000000e-08 > maximum iterations=40 > KSP Object: 1 MPI processes > type: gmres > restart=30, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > happy breakdown tolerance 1e-30 > maximum iterations=5000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-06, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: 1 MPI processes > type: bjacobi > number of blocks = 18000 > Local solve is same for all blocks, in the following KSP and PC > objects: > KSP Object: (sub_) 1 MPI processes > type: preonly > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > left preconditioning > using NONE norm type for convergence test > PC Object: (sub_) 1 MPI processes > type: lu > out-of-place factorization > tolerance for zero pivot 2.22045e-14 > matrix ordering: nd > factor fill ratio given 0., needed 0. > Factored matrix follows: > Mat Object: 1 MPI processes > type: mkl_pardiso > rows=6, cols=6 > package used to perform factorization: mkl_pardiso > total: nonzeros=26, allocated nonzeros=26 > total number of mallocs used during MatSetValues calls =0 > MKL_PARDISO run parameters: > MKL_PARDISO phase: 33 > MKL_PARDISO iparm[1]: 1 > MKL_PARDISO iparm[2]: 2 > MKL_PARDISO iparm[3]: 1 > MKL_PARDISO iparm[4]: 0 > MKL_PARDISO iparm[5]: 0 > MKL_PARDISO iparm[6]: 0 > MKL_PARDISO iparm[7]: 0 > MKL_PARDISO iparm[8]: 0 > MKL_PARDISO iparm[9]: 0 > MKL_PARDISO iparm[10]: 13 > MKL_PARDISO iparm[11]: 1 > MKL_PARDISO iparm[12]: 0 > MKL_PARDISO iparm[13]: 1 > MKL_PARDISO iparm[14]: 0 > MKL_PARDISO iparm[15]: 144 > MKL_PARDISO iparm[16]: 144 > MKL_PARDISO iparm[17]: 0 > MKL_PARDISO iparm[18]: 37 > MKL_PARDISO iparm[19]: 0 > MKL_PARDISO iparm[20]: 0 > MKL_PARDISO iparm[21]: 0 > MKL_PARDISO iparm[22]: 0 > MKL_PARDISO iparm[23]: 0 > MKL_PARDISO iparm[24]: 0 > MKL_PARDISO iparm[25]: 0 > MKL_PARDISO iparm[26]: 0 > MKL_PARDISO iparm[27]: 0 > MKL_PARDISO iparm[28]: 0 > MKL_PARDISO iparm[29]: 0 > MKL_PARDISO iparm[30]: 0 > MKL_PARDISO iparm[31]: 0 > MKL_PARDISO iparm[32]: 0 > MKL_PARDISO iparm[33]: 0 > MKL_PARDISO iparm[34]: -1 > MKL_PARDISO iparm[35]: 1 > MKL_PARDISO iparm[36]: 0 > MKL_PARDISO iparm[37]: 0 > MKL_PARDISO iparm[38]: 0 > MKL_PARDISO iparm[39]: 0 > MKL_PARDISO iparm[40]: 0 > MKL_PARDISO iparm[41]: 0 > MKL_PARDISO iparm[42]: 0 > MKL_PARDISO iparm[43]: 0 > MKL_PARDISO iparm[44]: 0 > MKL_PARDISO iparm[45]: 0 > MKL_PARDISO iparm[46]: 0 > MKL_PARDISO iparm[47]: 0 > MKL_PARDISO iparm[48]: 0 > MKL_PARDISO iparm[49]: 0 > MKL_PARDISO iparm[50]: 0 > MKL_PARDISO iparm[51]: 0 > MKL_PARDISO iparm[52]: 0 > MKL_PARDISO iparm[53]: 0 > MKL_PARDISO iparm[54]: 0 > MKL_PARDISO iparm[55]: 0 > MKL_PARDISO iparm[56]: 0 > MKL_PARDISO iparm[57]: -1 > MKL_PARDISO iparm[58]: 0 > MKL_PARDISO iparm[59]: 0 > MKL_PARDISO iparm[60]: 0 > MKL_PARDISO iparm[61]: 144 > MKL_PARDISO iparm[62]: 145 > MKL_PARDISO iparm[63]: 21 > MKL_PARDISO iparm[64]: 0 > MKL_PARDISO maxfct: 1 > MKL_PARDISO mnum: 1 > MKL_PARDISO mtype: 11 > MKL_PARDISO n: 6 > MKL_PARDISO nrhs: 1 > MKL_PARDISO msglvl: 0 > linear system matrix = precond matrix: > Mat Object: 1 MPI processes > type: seqaij > rows=6, cols=6 > total: nonzeros=26, allocated nonzeros=26 > total number of mallocs used during MatSetValues calls =0 > using I-node routines: found 4 nodes, limit used is 5 > linear system matrix = precond matrix: > Mat Object: 1 MPI processes > type: seqaij > rows=108000, cols=108000 > total: nonzeros=2868000, allocated nonzeros=8640000 > total number of mallocs used during MatSetValues calls =0 > not using I-node routines > ************************************************************************************************************************ > *** WIDEN YOUR WINDOW TO 120 CHARACTERS. Use 'enscript -r > -fCourier9' to print this document *** > ************************************************************************************************************************ > > ---------------------------------------------- PETSc Performance > Summary: ---------------------------------------------- > > E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe > on a named ALIREZA-PC with 1 processor, by AliReza Tue Aug 28 13:57:09 2018 > Using Petsc Development GIT revision: v3.9.3-1238-gce82fdcfd6 GIT Date: > 2018-08-27 15:47:19 -0500 > > Max Max/Min Avg Total > Time (sec): 1.353e+02 1.000 1.353e+02 > Objects: 1.980e+05 1.000 1.980e+05 > Flop: 2.867e+07 1.000 2.867e+07 2.867e+07 > Flop/sec: 2.119e+05 1.000 2.119e+05 2.119e+05 > MPI Messages: 0.000e+00 0.000 0.000e+00 0.000e+00 > MPI Message Lengths: 0.000e+00 0.000 0.000e+00 0.000e+00 > MPI Reductions: 0.000e+00 0.000 > > Flop counting convention: 1 flop = 1 real number operation of type > (multiply/divide/add/subtract) > e.g., VecAXPY() for real vectors of length > N --> 2N flop > and VecAXPY() for complex vectors of length > N --> 8N flop > > Summary of Stages: ----- Time ------ ----- Flop ------ --- Messages > --- -- Message Lengths -- -- Reductions -- > Avg %Total Avg %Total Count > %Total Avg %Total Count %Total > 0: Main Stage: 1.3529e+02 100.0% 2.8668e+07 100.0% 0.000e+00 > 0.0% 0.000e+00 0.0% 0.000e+00 0.0% > > ------------------------------------------------------------------------------------------------------------------------ > See the 'Profiling' chapter of the users' manual for details on > interpreting output. > Phase summary info: > Count: number of times phase was executed > Time and Flop: Max - maximum over all processors > Ratio - ratio of maximum to minimum over all processors > Mess: number of messages sent > AvgLen: average message length (bytes) > Reduct: number of global reductions > Global: entire computation > Stage: stages of a computation. Set stages with PetscLogStagePush() > and PetscLogStagePop(). > %T - percent time in this phase %F - percent flop in this > phase > %M - percent messages in this phase %L - percent message > lengths in this phase > %R - percent reductions in this phase > Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time > over all processors) > ------------------------------------------------------------------------------------------------------------------------ > Event Count Time (sec) > Flop --- Global --- --- Stage ---- Total > Max Ratio Max Ratio Max Ratio Mess AvgLen > Reduct %T %F %M %L %R %T %F %M %L %R Mflop/s > ------------------------------------------------------------------------------------------------------------------------ > > --- Event Stage 0: Main Stage > > BuildTwoSidedF 2 1.0 1.2701e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > SNESSolve 1 1.0 1.1583e+02 1.0 2.87e+07 1.0 0.0e+00 0.0e+00 > 0.0e+00 86100 0 0 0 86100 0 0 0 0 > SNESFunctionEval 2 1.0 5.4101e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 > SNESJacobianEval 1 1.0 9.3770e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 69 0 0 0 0 69 0 0 0 0 0 > SNESLineSearch 1 1.0 3.1033e+00 1.0 6.82e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 2 24 0 0 0 2 24 0 0 0 2 > VecDot 1 1.0 1.8688e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 1 0 0 0 0 1 0 0 0 1156 > VecMDot 3 1.0 9.9299e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 5 0 0 0 0 5 0 0 0 1305 > VecNorm 7 1.0 6.0845e-03 1.0 1.51e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 5 0 0 0 0 5 0 0 0 248 > VecScale 4 1.0 1.4437e+00 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 1 2 0 0 0 1 2 0 0 0 0 > VecCopy 3 1.0 1.6059e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 > VecSet 90002 1.0 1.3843e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecAXPY 1 1.0 3.1733e-01 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 1 0 0 0 0 1 0 0 0 1 > VecWAXPY 1 1.0 2.2665e-04 1.0 1.08e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 477 > VecMAXPY 4 1.0 8.6085e-04 1.0 1.94e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 7 0 0 0 0 7 0 0 0 2258 > VecAssemblyBegin 2 1.0 1.6379e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecAssemblyEnd 2 1.0 1.4112e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecReduceArith 2 1.0 3.1304e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 2 0 0 0 0 2 0 0 0 1380 > VecReduceComm 1 1.0 2.1382e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecNormalize 4 1.0 1.4441e+00 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 1 5 0 0 0 1 5 0 0 0 1 > MatMult 4 1.0 2.0402e-02 1.0 2.25e+07 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 79 0 0 0 0 79 0 0 0 1103 > MatSolve 72000 1.0 5.3514e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 > MatLUFactorSym 18000 1.0 1.9405e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 > MatLUFactorNum 18000 1.0 1.8373e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatAssemblyBegin 18002 1.0 1.0409e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatAssemblyEnd 18002 1.0 3.3879e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatGetRowIJ 18000 1.0 3.1819e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatCreateSubMats 1 1.0 3.7015e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatGetOrdering 18000 1.0 3.0787e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatZeroEntries 1 1.0 2.7952e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatView 3 1.0 2.9153e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > KSPSetUp 18001 1.0 7.5898e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > KSPSolve 1 1.0 1.6244e+01 1.0 2.16e+07 1.0 0.0e+00 0.0e+00 > 0.0e+00 12 75 0 0 0 12 75 0 0 0 1 > KSPGMRESOrthog 3 1.0 8.4669e-02 1.0 2.59e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00 0 9 0 0 0 0 9 0 0 0 31 > PCSetUp 18001 1.0 3.3536e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 2 0 0 0 0 2 0 0 0 0 0 > PCSetUpOnBlocks 1 1.0 2.5973e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 2 0 0 0 0 2 0 0 0 0 0 > PCApply 4 1.0 6.2752e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 5 0 0 0 0 5 0 0 0 0 0 > PCApplyOnBlocks 72000 1.0 5.9278e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 > ------------------------------------------------------------------------------------------------------------------------ > > Memory usage is given in bytes: > > Object Type Creations Destructions Memory Descendants' Mem. > Reports information only for process 0. > > --- Event Stage 0: Main Stage > > SNES 1 0 0 0. > DMSNES 1 0 0 0. > SNESLineSearch 1 0 0 0. > Vector 36020 0 0 0. > Matrix 36001 0 0 0. > Distributed Mesh 2 0 0 0. > Index Set 90000 36000 29088000 0. > Star Forest Graph 4 0 0 0. > Discrete System 2 0 0 0. > Krylov Solver 18001 0 0 0. > DMKSP interface 1 0 0 0. > Preconditioner 18001 0 0 0. > Viewer 1 0 0 0. > ======================================================================================================================== > Average time to get PetscTime(): 1.28294e-07 > #PETSc Option Table entries: > -ksp_atol 1e-6 > -ksp_rtol 1e-5 > -snes_rtol 1e-4 > -sub_ksp_type preonly > -sub_pc_factor_mat_solver_type mkl_pardiso > -sub_pc_type lu > #End of PETSc Option Table entries > Compiled without FORTRAN kernels > Compiled with full precision matrices (default) > sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 > sizeof(PetscScalar) 8 sizeof(PetscInt) 4 > Configure options: --prefix=/home/alireza/PetscGit > --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl > --with-hypre-incl > ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include > --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib > --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in > clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib > ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" > --with-mpi-include=/cygdrive/E/Program_Fi > les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include > --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int > el64/lib/impi.lib > --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe > --with-debugging=0 --with-blas > -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool > s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" > -FFLAGS="-MT -O2 -Qopenmp" > ----------------------------------------- > Libraries compiled on 2018-08-27 22:42:15 on AliReza-PC > Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit > Using PETSc directory: /home/alireza/PetscGit > Using PETSc arch: > ----------------------------------------- > > Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl > -O2 -MT -wd4996 -Qopenmp > Using Fortran compiler: > /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp > -fpp > ----------------------------------------- > > Using include paths: -I/home/alireza/PetscGit/include > -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include > -I/cygdrive/E/hypre-2.11.2/ > Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include > -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include > ----------------------------------------- > > Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl > Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe > ifort > Using libraries: -L/home/alireza/PetscGit/lib > -L/home/alireza/PetscGit/lib -lpetsc > /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib > /cygdrive/E/Trilinos-master/Bins/lib > /ml.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and > _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib > Gdi32.lib User32.lib > Advapi32.lib Kernel32.lib Ws2_32.lib > ----------------------------------------- > > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ From bsmith at mcs.anl.gov Tue Aug 28 13:25:51 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Tue, 28 Aug 2018 18:25:51 +0000 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> Message-ID: 1) PetscMalloc() is never valid or needed in Fortran 2) there is no reason to use DMSetMatrixPreallocateOnly() just use DMCreateMatrix() assuming that using a DM (DMDA, DMPLEX, etc) is suitable for your problem. At this end we are totally guessing at what you are doing and so have little help we can provide. A simple, nonworking code that tries to do what you would need would help us a great deal in understanding that you are trying to do. Barry > On Aug 28, 2018, at 1:18 PM, Manuel Valera wrote: > > Matthew, PetscMalloc gives the same error, > > Barry, it would be very hard for me to get the code to a minimum working example, i guess all i need to understand is how to setup a DM matrix with DMSetMatrixPreallocateOnly() instead of MatMPIAIJSetPreallocation() as we were doing before, is there a simple example who does this in Fortran? > > Is the PetscMalloc call needed? is 'call PetscMalloc(1,row,ierr)' a valid, compilable call to PetscMalloc? what other reason may there be for this error to happen ? > > Just remembering, that trying to setup the matrix with the MatAIJSetPreallocation() brings up an error to acknowledge the viennacl datatypes and that's why i'm trying to make this change on your recommendation, > > Thanks for your help, > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. wrote: > > Send your code in a way we can compile and run it; it must be some simple issue that is hard to communicate in email. > > Barry > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera wrote: > > > > Hello everyone, > > > > I just had time to work on this again, and checked the code for errors on the matrix entries, this is the exact code i was using for creating the matrix without DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and it worked that way, but trying this way i get the same 'Column too large' error using any number at the column position of MatSetValues, > > > > I have set up my code to print the column argument (n) of MatSetValues and in this case is 7 (lower than 124), it still gives error, even entering a specific number in the MatSetValues column argument position gives the same error. > > > > So next i went back to ex.50 here: http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html and it has a very similar structure except the PetscMalloc1() call, so i tried adding that and got: > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined reference to `petscmalloc1_' > > > > Any ideas on this behaviour? > > > > Thanks so much, > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. wrote: > > > > Column too large: col 10980 max 124 > > > > You need to check the code that is generating the matrix entries. The matrix has 124 columns but you are attempting to put a value at column 10980 > > > > Barry > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera wrote: > > > > > > Thanks Matthew and Barry, > > > > > > Now my code looks like: > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > call DMCreateMatrix(daDummy,A,ierr) > > > call MatSetFromOptions(A,ierr) > > > call MatSetUp(A,ierr) > > > [...] > > > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > [...] > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > And i get a different error, now is: > > > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > [0]PETSC ERROR: Argument out of range > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 19:40:00 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. wrote: > > > > > > Should be > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > and remove the rest. You need to set the type of Mat you want the DM to return BEFORE you create the matrix. > > > > > > Barry > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera wrote: > > > > > > > > Ok thanks for clarifying that, i wasn't sure if there were different types, > > > > > > > > Here is a stripped down version of my code, it seems like the preallocation is working now since the matrix population part is working without problem, but here it is for illustration purposes: > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > call MatSetFromOptions(A,ierr) > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > call MatSetUp(A,ierr) > > > > [...] > > > > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > [...] > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > Adding the first line there did the trick, > > > > > > > > Now the problem seems to be the program is not recognizing the matrix as ViennaCL type when i try with more than one processor, i get now: > > > > > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [0]PETSC ERROR: No support for this operation for this object type > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 14:44:22 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > When running with: > > > > > > > > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley wrote: > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera wrote: > > > > It seems to be resumed on: I do not know how to preallocate a DM Matrix correctly. > > > > > > > > There is only one matrix type, Mat. There are no separate DM matrices. A DM can create a matrix for you > > > > using DMCreateMatrix(), but that is a Mat and it is preallocated correctly. I am not sure what you are doing. > > > > > > > > Thanks, > > > > > > > > Matt > > > > > > > > The interesting part is that it only breaks when i need to populate a GPU matrix from MPI, so kudos on that, but it seems i need to do better on my code to get this setup working, > > > > > > > > Any help would be appreciated, > > > > > > > > Thanks, > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley wrote: > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera wrote: > > > > Thanks Matthew, > > > > > > > > I try to do that when calling: > > > > > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > But i am not aware on how to do this for the DM if it needs something more specific/different, > > > > > > > > The error says that your preallocation is wrong for the values you are putting in. The DM does not control either, > > > > so I do not understand your email. > > > > > > > > Thanks, > > > > > > > > Matt > > > > > > > > Thanks, > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley wrote: > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera wrote: > > > > Hello PETSc devs, > > > > > > > > I am running into an error when trying to use the MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs for MATSEQAIJVIENNACL type in one processor. The error happens when calling MatSetValues for this specific configuration. It does not occur when using MPI DMMatrix types only. > > > > > > > > The DM properly preallocates the matrix. I am assuming you do not here. > > > > > > > > Matt > > > > > > > > Any help will be appreciated, > > > > > > > > Thanks, > > > > > > > > > > > > > > > > My program call: > > > > > > > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl -pc_type saviennacl -log_view > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > [1]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [1]PETSC ERROR: Argument out of range > > > > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, 50) into matrix > > > > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 15 13:10:44 2018 > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > My Code structure: > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > call MatSetFromOptions(A,ierr) > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > > if (numprocs > 1) then ! set matrix type parallel > > > > ! Get local size > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > call VecDestroy(Tmpnat,ierr) > > > > ! Set matrix > > > > #ifdef GPU > > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > print*,'SETTING GPU TYPES' > > > > #else > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > > #endif > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > else ! set matrix type sequential > > > > #ifdef GPU > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > print*,'SETTING GPU TYPES' > > > > #else > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > > call MatSetType(A,MATSEQAIJ,ierr) > > > > #endif > > > > call MatSetUp(A,ierr) > > > > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > do k=zstart,zend-1 > > > > do j=ystart,yend-1 > > > > do i=xstart,xend-1 > > > > [..] > > > > call MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > 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 > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > -- > > > > 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 > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > -- > > > > 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 > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > From bsmith at mcs.anl.gov Tue Aug 28 16:54:04 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Tue, 28 Aug 2018 21:54:04 +0000 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <871saj1pxq.fsf@jedbrown.org> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> Message-ID: <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> Ali, In the branch barry/feature-PCVPBJACOBI (see src/snes/examples/tutorials/ex5.c) I have implemented PCVPBJACOBI that is a point block Jacobi with variable size blocks. It has very little testing. Could you please try your code with it; you should see very very similar convergence history with this branch and the previous approach you used (the only numerical difference between the two approaches is that this one uses a dense LU factorization for each small block while the previous used a sparse factorization). This new one should also be slightly faster in the KSPSolve(). Thanks Barry > On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: > > "Smith, Barry F." writes: > >> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c > > Note that this example is block Jacobi with O(1) sparse blocks per > process, not variable-sized point-block Jacobi which I think is what Ali > had in mind. > >> Please let us know if it works for you and if you have any questions or problems. >> >> Barry >> >> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >> >> Sorry for the runaround with so many emails. >> >> >>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>> >>> Hi, >>> >>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>> >>> Below is a part of my code. It is run serially. Any help is much appreciated. >>> >>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>> CHKERRQ(ierr); >>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>> CHKERRQ(ierr); >>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>> CHKERRQ(ierr); >>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>> CHKERRQ(ierr); >>> ierr = SNESSetType(snes, SNESNEWTONLS); >>> CHKERRQ(ierr); >>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>> CHKERRQ(ierr); >>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>> CHKERRQ(ierr); >>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>> CHKERRQ(ierr); >>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>> CHKERRQ(ierr); >>> >>> SNESSetUp(snes); >>> CHKERRQ(ierr); >>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>> CHKERRQ(ierr); >>> >>> for (i = 0; i < nLocal; i++) { >>> ierr = KSPGetPC(subKSP[i], &SubPc); >>> CHKERRQ(ierr); >>> ierr = PCSetType(SubPc, PCLU); >>> CHKERRQ(ierr); >>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>> CHKERRQ(ierr); >>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>> CHKERRQ(ierr); >>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>> CHKERRQ(ierr); >>> } >>> ierr = SNESSolve(snes, NULL, Petsc_X); >>> CHKERRQ(ierr); >>> >>> >>> >>> -- >>> Ali Reza Khaz?ali >>> Assistant Professor of Petroleum Engineering, >>> Department of Chemical Engineering >>> Isfahan University of Technology >>> Isfahan, Iran >>> From zhaonanavril at gmail.com Tue Aug 28 17:33:40 2018 From: zhaonanavril at gmail.com (NAN ZHAO) Date: Tue, 28 Aug 2018 17:33:40 -0500 Subject: [petsc-users] exit kspsolve at half of the max iterations if residual is not reduced by an order Message-ID: Dear all, I am trying to find ways to speed up my pests kspsolve, my old code use an older solver and it exit the solving loop when residual is not reduced by a certain amount compared with initial residual, and then redo the computation with other tricks. I am wondering if PETSC has this function. Thanks, Nan -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Tue Aug 28 17:39:47 2018 From: jed at jedbrown.org (Jed Brown) Date: Tue, 28 Aug 2018 16:39:47 -0600 Subject: [petsc-users] exit kspsolve at half of the max iterations if residual is not reduced by an order In-Reply-To: References: Message-ID: <87zhx65d58.fsf@jedbrown.org> You can use any convergence test you want, see SNESSetConvergenceTest() if tolerances don't cut it for you. You might also consider nested solvers/nonlinear preconditioning. NAN ZHAO writes: > Dear all, > > I am trying to find ways to speed up my pests kspsolve, my old code use an > older solver and it exit the solving loop when residual is not reduced by a > certain amount compared with initial residual, and then redo the > computation with other tricks. I am wondering if PETSC has this function. > > Thanks, > Nan From mvalera-w at sdsu.edu Tue Aug 28 18:21:28 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Tue, 28 Aug 2018 16:21:28 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> Message-ID: Ok, i found the culprit and we can close this thread, The problem was a missing variable for setting the maximum columns, which i deleted at some point without realizing. The error message was too ambiguous to catch this so i had to compare with a previous working version of the arguments of MatSetValues, it was evident then. Good news is that i can now set the values with the viennacl types too, Thanks for your kind help, Manuel On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. wrote: > > 1) PetscMalloc() is never valid or needed in Fortran > > 2) there is no reason to use DMSetMatrixPreallocateOnly() just use > DMCreateMatrix() assuming that using a DM (DMDA, DMPLEX, etc) is suitable > for your problem. > > At this end we are totally guessing at what you are doing and so have > little help we can provide. A simple, nonworking code that tries to do > what you would need would help us a great deal in understanding that you > are trying to do. > > Barry > > > > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera wrote: > > > > Matthew, PetscMalloc gives the same error, > > > > Barry, it would be very hard for me to get the code to a minimum working > example, i guess all i need to understand is how to setup a DM matrix with > DMSetMatrixPreallocateOnly() instead of MatMPIAIJSetPreallocation() as we > were doing before, is there a simple example who does this in Fortran? > > > > Is the PetscMalloc call needed? is 'call PetscMalloc(1,row,ierr)' a > valid, compilable call to PetscMalloc? what other reason may there be for > this error to happen ? > > > > Just remembering, that trying to setup the matrix with the > MatAIJSetPreallocation() brings up an error to acknowledge the viennacl > datatypes and that's why i'm trying to make this change on your > recommendation, > > > > Thanks for your help, > > > > > > > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. > wrote: > > > > Send your code in a way we can compile and run it; it must be some > simple issue that is hard to communicate in email. > > > > Barry > > > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera wrote: > > > > > > Hello everyone, > > > > > > I just had time to work on this again, and checked the code for errors > on the matrix entries, this is the exact code i was using for creating the > matrix without DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation > and it worked that way, but trying this way i get the same 'Column too > large' error using any number at the column position of MatSetValues, > > > > > > I have set up my code to print the column argument (n) of MatSetValues > and in this case is 7 (lower than 124), it still gives error, even entering > a specific number in the MatSetValues column argument position gives the > same error. > > > > > > So next i went back to ex.50 here: http://www.mcs.anl.gov/petsc/ > petsc-current/src/ts/examples/tutorials/ex50.c.html and it has a very > similar structure except the PetscMalloc1() call, so i tried adding that > and got: > > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined reference > to `petscmalloc1_' > > > > > > Any ideas on this behaviour? > > > > > > Thanks so much, > > > > > > > > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > wrote: > > > > > > Column too large: col 10980 max 124 > > > > > > You need to check the code that is generating the matrix entries. > The matrix has 124 columns but you are attempting to put a value at column > 10980 > > > > > > Barry > > > > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera > wrote: > > > > > > > > Thanks Matthew and Barry, > > > > > > > > Now my code looks like: > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > call MatSetFromOptions(A,ierr) > > > > call MatSetUp(A,ierr) > > > > [...] > > > > call MatSetValues(A,1,row,sumpos, > pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > [...] > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > And i get a different error, now is: > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > [0]PETSC ERROR: Argument out of range > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Wed Aug 15 19:40:00 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > wrote: > > > > > > > > Should be > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > and remove the rest. You need to set the type of Mat you want the > DM to return BEFORE you create the matrix. > > > > > > > > Barry > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera > wrote: > > > > > > > > > > Ok thanks for clarifying that, i wasn't sure if there were > different types, > > > > > > > > > > Here is a stripped down version of my code, it seems like the > preallocation is working now since the matrix population part is working > without problem, but here it is for illustration purposes: > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > call MatSetFromOptions(A,ierr) > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > call MatSetUp(A,ierr) > > > > > [...] > > > > > call MatSetValues(A,1,row,sumpos, > pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > [...] > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > Adding the first line there did the trick, > > > > > > > > > > Now the problem seems to be the program is not recognizing the > matrix as ViennaCL type when i try with more than one processor, i get now: > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > > [0]PETSC ERROR: No support for this operation for this object type > > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by > valera Wed Aug 15 14:44:22 2018 > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > > > When running with: > > > > > > > > > > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ > jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type > aijviennacl -pc_type saviennacl -log_view > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley < > knepley at gmail.com> wrote: > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > wrote: > > > > > It seems to be resumed on: I do not know how to preallocate a DM > Matrix correctly. > > > > > > > > > > There is only one matrix type, Mat. There are no separate DM > matrices. A DM can create a matrix for you > > > > > using DMCreateMatrix(), but that is a Mat and it is preallocated > correctly. I am not sure what you are doing. > > > > > > > > > > Thanks, > > > > > > > > > > Matt > > > > > > > > > > The interesting part is that it only breaks when i need to > populate a GPU matrix from MPI, so kudos on that, but it seems i need to do > better on my code to get this setup working, > > > > > > > > > > Any help would be appreciated, > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley < > knepley at gmail.com> wrote: > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > wrote: > > > > > Thanks Matthew, > > > > > > > > > > I try to do that when calling: > > > > > > > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > > > > > But i am not aware on how to do this for the DM if it needs > something more specific/different, > > > > > > > > > > The error says that your preallocation is wrong for the values you > are putting in. The DM does not control either, > > > > > so I do not understand your email. > > > > > > > > > > Thanks, > > > > > > > > > > Matt > > > > > > > > > > Thanks, > > > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley < > knepley at gmail.com> wrote: > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > wrote: > > > > > Hello PETSc devs, > > > > > > > > > > I am running into an error when trying to use the > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs for > MATSEQAIJVIENNACL type in one processor. The error happens when calling > MatSetValues for this specific configuration. It does not occur when using > MPI DMMatrix types only. > > > > > > > > > > The DM properly preallocates the matrix. I am assuming you do not > here. > > > > > > > > > > Matt > > > > > > > > > > Any help will be appreciated, > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > My program call: > > > > > > > > > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ > jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type > aijviennacl -pc_type saviennacl -log_view > > > > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > > > [1]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > > [1]PETSC ERROR: Argument out of range > > > > > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, > 50) into matrix > > > > > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > > > [1]PETSC ERROR: Petsc Development GIT revision: > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by > valera Wed Aug 15 13:10:44 2018 > > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > My Code structure: > > > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > call MatSetFromOptions(A,ierr) > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > > > if (numprocs > 1) then ! set matrix type parallel > > > > > ! Get local size > > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > > call VecDestroy(Tmpnat,ierr) > > > > > ! Set matrix > > > > > #ifdef GPU > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > print*,'SETTING GPU TYPES' > > > > > #else > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > > > #endif > > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > else ! set matrix type sequential > > > > > #ifdef GPU > > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > > print*,'SETTING GPU TYPES' > > > > > #else > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > > > call MatSetType(A,MATSEQAIJ,ierr) > > > > > #endif > > > > > call MatSetUp(A,ierr) > > > > > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > > > do k=zstart,zend-1 > > > > > do j=ystart,yend-1 > > > > > do i=xstart,xend-1 > > > > > [..] > > > > > call MatSetValues(A,1,row,sumpos, > pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > 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 > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > -- > > > > > 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 > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > -- > > > > > 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 > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mvalera-w at sdsu.edu Tue Aug 28 18:33:52 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Tue, 28 Aug 2018 16:33:52 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> Message-ID: Talked too fast, After fixing that problem, i tried more than one mpi processor and got the following: Matrix type: mpiaijviennacl Of sizes: 125 x 125 Matrix type: mpiaijviennacl Of sizes: 125 x 125 [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: No support for this operation for this object type [0]PETSC ERROR: Currently only handles ViennaCL matrices [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl [1]PETSC ERROR: #1 User provided function() line 0 in unknown file -------------------------------------------------------------------------- MPI_ABORT was invoked on rank 1 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. -------------------------------------------------------------------------- [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end [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. [0]PETSC ERROR: [0] PetscCommDuplicate line 130 /home/valera/petsc/src/sys/objects/tagm.c [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 /home/valera/petsc/src/sys/objects/inherit.c [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/is/interface/isreg.c [0]PETSC ERROR: [0] ISCreateGeneral line 668 /home/valera/petsc/src/vec/is/is/impls/general/general.c [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: Signal received [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl [0]PETSC ERROR: #3 User provided function() line 0 in unknown file [node50:30582] 1 more process has sent help message help-mpi-api.txt / mpi-abort [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages It is currently running in 1 mpi processor + GPU but i would like to call at least 16 mpi processors + GPU to do the rest of the data management who is not part of the main laplacian on the mpi and the laplacian solution on the GPU, is this currently possible? Thanks for your help, On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera wrote: > Ok, i found the culprit and we can close this thread, > > The problem was a missing variable for setting the maximum columns, which > i deleted at some point without realizing. The error message was too > ambiguous to catch this so i had to compare with a previous working version > of the arguments of MatSetValues, it was evident then. > > Good news is that i can now set the values with the viennacl types too, > > Thanks for your kind help, > > Manuel > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. > wrote: > >> >> 1) PetscMalloc() is never valid or needed in Fortran >> >> 2) there is no reason to use DMSetMatrixPreallocateOnly() just use >> DMCreateMatrix() assuming that using a DM (DMDA, DMPLEX, etc) is suitable >> for your problem. >> >> At this end we are totally guessing at what you are doing and so have >> little help we can provide. A simple, nonworking code that tries to do >> what you would need would help us a great deal in understanding that you >> are trying to do. >> >> Barry >> >> >> >> >> >> > On Aug 28, 2018, at 1:18 PM, Manuel Valera wrote: >> > >> > Matthew, PetscMalloc gives the same error, >> > >> > Barry, it would be very hard for me to get the code to a minimum >> working example, i guess all i need to understand is how to setup a DM >> matrix with DMSetMatrixPreallocateOnly() instead of >> MatMPIAIJSetPreallocation() as we were doing before, is there a simple >> example who does this in Fortran? >> > >> > Is the PetscMalloc call needed? is 'call PetscMalloc(1,row,ierr)' a >> valid, compilable call to PetscMalloc? what other reason may there be for >> this error to happen ? >> > >> > Just remembering, that trying to setup the matrix with the >> MatAIJSetPreallocation() brings up an error to acknowledge the viennacl >> datatypes and that's why i'm trying to make this change on your >> recommendation, >> > >> > Thanks for your help, >> > >> > >> > >> > >> > >> > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >> wrote: >> > >> > Send your code in a way we can compile and run it; it must be some >> simple issue that is hard to communicate in email. >> > >> > Barry >> > >> > >> > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >> wrote: >> > > >> > > Hello everyone, >> > > >> > > I just had time to work on this again, and checked the code for >> errors on the matrix entries, this is the exact code i was using for >> creating the matrix without DMSetMatrixPreallocateOnly, using >> MatMPIAIJSetPreallocation and it worked that way, but trying this way i get >> the same 'Column too large' error using any number at the column position >> of MatSetValues, >> > > >> > > I have set up my code to print the column argument (n) of >> MatSetValues and in this case is 7 (lower than 124), it still gives error, >> even entering a specific number in the MatSetValues column argument >> position gives the same error. >> > > >> > > So next i went back to ex.50 here: http://www.mcs.anl.gov/petsc/p >> etsc-current/src/ts/examples/tutorials/ex50.c.html and it has a very >> similar structure except the PetscMalloc1() call, so i tried adding that >> and got: >> > > >> > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined >> reference to `petscmalloc1_' >> > > >> > > Any ideas on this behaviour? >> > > >> > > Thanks so much, >> > > >> > > >> > > >> > > >> > > >> > > >> > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >> wrote: >> > > >> > > Column too large: col 10980 max 124 >> > > >> > > You need to check the code that is generating the matrix entries. >> The matrix has 124 columns but you are attempting to put a value at column >> 10980 >> > > >> > > Barry >> > > >> > > >> > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >> wrote: >> > > > >> > > > Thanks Matthew and Barry, >> > > > >> > > > Now my code looks like: >> > > > >> > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >> > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > call MatSetFromOptions(A,ierr) >> > > > call MatSetUp(A,ierr) >> > > > [...] >> > > > call MatSetValues(A,1,row,sumpos,po >> s(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> > > > [...] >> > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > >> > > > And i get a different error, now is: >> > > > >> > > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > [0]PETSC ERROR: Argument out of range >> > > > [0]PETSC ERROR: Column too large: col 10980 max 124 >> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > > [0]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Wed Aug 15 19:40:00 2018 >> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in >> /home/valera/petsc/src/mat/impls/aij/seq/aij.c >> > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >> /home/valera/petsc/src/mat/interface/matrix.c >> > > > >> > > > >> > > > Thanks again, >> > > > >> > > > >> > > > >> > > > >> > > > >> > > > >> > > > >> > > > >> > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. < >> bsmith at mcs.anl.gov> wrote: >> > > > >> > > > Should be >> > > > >> > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > >> > > > and remove the rest. You need to set the type of Mat you want the >> DM to return BEFORE you create the matrix. >> > > > >> > > > Barry >> > > > >> > > > >> > > > >> > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >> wrote: >> > > > > >> > > > > Ok thanks for clarifying that, i wasn't sure if there were >> different types, >> > > > > >> > > > > Here is a stripped down version of my code, it seems like the >> preallocation is working now since the matrix population part is working >> without problem, but here it is for illustration purposes: >> > > > > >> > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >> > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > call MatSetFromOptions(A,ierr) >> > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > call MatSetUp(A,ierr) >> > > > > [...] >> > > > > call MatSetValues(A,1,row,sumpos,po >> s(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> > > > > [...] >> > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > >> > > > > Adding the first line there did the trick, >> > > > > >> > > > > Now the problem seems to be the program is not recognizing the >> matrix as ViennaCL type when i try with more than one processor, i get now: >> > > > > >> > > > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > > [0]PETSC ERROR: No support for this operation for this object type >> > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >> > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > > > [0]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >> valera Wed Aug 15 14:44:22 2018 >> > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >> /home/valera/petsc/src/ksp/pc/interface/precon.c >> > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >> > > > > >> > > > > When running with: >> > > > > >> > > > > mpirun -n 1 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >> aijviennacl -pc_type saviennacl -log_view >> > > > > >> > > > > >> > > > > Thanks, >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley < >> knepley at gmail.com> wrote: >> > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >> wrote: >> > > > > It seems to be resumed on: I do not know how to preallocate a DM >> Matrix correctly. >> > > > > >> > > > > There is only one matrix type, Mat. There are no separate DM >> matrices. A DM can create a matrix for you >> > > > > using DMCreateMatrix(), but that is a Mat and it is preallocated >> correctly. I am not sure what you are doing. >> > > > > >> > > > > Thanks, >> > > > > >> > > > > Matt >> > > > > >> > > > > The interesting part is that it only breaks when i need to >> populate a GPU matrix from MPI, so kudos on that, but it seems i need to do >> better on my code to get this setup working, >> > > > > >> > > > > Any help would be appreciated, >> > > > > >> > > > > Thanks, >> > > > > >> > > > > >> > > > > >> > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley < >> knepley at gmail.com> wrote: >> > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >> wrote: >> > > > > Thanks Matthew, >> > > > > >> > > > > I try to do that when calling: >> > > > > >> > > > > call MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > >> > > > > But i am not aware on how to do this for the DM if it needs >> something more specific/different, >> > > > > >> > > > > The error says that your preallocation is wrong for the values >> you are putting in. The DM does not control either, >> > > > > so I do not understand your email. >> > > > > >> > > > > Thanks, >> > > > > >> > > > > Matt >> > > > > >> > > > > Thanks, >> > > > > >> > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley < >> knepley at gmail.com> wrote: >> > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >> wrote: >> > > > > Hello PETSc devs, >> > > > > >> > > > > I am running into an error when trying to use the >> MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs for >> MATSEQAIJVIENNACL type in one processor. The error happens when calling >> MatSetValues for this specific configuration. It does not occur when using >> MPI DMMatrix types only. >> > > > > >> > > > > The DM properly preallocates the matrix. I am assuming you do not >> here. >> > > > > >> > > > > Matt >> > > > > >> > > > > Any help will be appreciated, >> > > > > >> > > > > Thanks, >> > > > > >> > > > > >> > > > > >> > > > > My program call: >> > > > > >> > > > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >> jid=tiny_cuda_test_n2 -ksp_type cg -dm_vec_type viennacl -dm_mat_type >> aijviennacl -pc_type saviennacl -log_view >> > > > > >> > > > > >> > > > > The error (repeats after each MatSetValues call): >> > > > > >> > > > > [1]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > > [1]PETSC ERROR: Argument out of range >> > > > > [1]PETSC ERROR: Inserting a new nonzero at global row/column (75, >> 50) into matrix >> > > > > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > > > [1]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >> valera Wed Aug 15 13:10:44 2018 >> > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >> > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >> /home/valera/petsc/src/mat/interface/matrix.c >> > > > > >> > > > > >> > > > > My Code structure: >> > > > > >> > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > call MatSetFromOptions(A,ierr) >> > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >> > > > > if (numprocs > 1) then ! set matrix type parallel >> > > > > ! Get local size >> > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >> > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) >> > > > > call VecDestroy(Tmpnat,ierr) >> > > > > ! Set matrix >> > > > > #ifdef GPU >> > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >> > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > print*,'SETTING GPU TYPES' >> > > > > #else >> > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >> > > > > call DMSetMatType(daDummy,VECMPI,ierr) >> > > > > call MatSetType(A,MATMPIAIJ,ierr)! >> > > > > #endif >> > > > > call MatMPIAIJSetPreallocation(A,19 >> ,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >> > > > > else ! set matrix type sequential >> > > > > #ifdef GPU >> > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >> > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >> > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >> > > > > print*,'SETTING GPU TYPES' >> > > > > #else >> > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >> > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >> > > > > call MatSetType(A,MATSEQAIJ,ierr) >> > > > > #endif >> > > > > call MatSetUp(A,ierr) >> > > > > call getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >> > > > > >> > > > > do k=zstart,zend-1 >> > > > > do j=ystart,yend-1 >> > > > > do i=xstart,xend-1 >> > > > > [..] >> > > > > call MatSetValues(A,1,row,sumpos,po >> s(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >> > > > > [..] >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > -- >> > > > > 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 >> > > > > >> > > > > https://www.cse.buffalo.edu/~knepley/ >> > > > > >> > > > > >> > > > > >> > > > > -- >> > > > > 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 >> > > > > >> > > > > https://www.cse.buffalo.edu/~knepley/ >> > > > > >> > > > > >> > > > > >> > > > > -- >> > > > > 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 >> > > > > >> > > > > https://www.cse.buffalo.edu/~knepley/ >> > > > > >> > > > >> > > > >> > > >> > > >> > >> > >> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From rupp at iue.tuwien.ac.at Tue Aug 28 23:34:23 2018 From: rupp at iue.tuwien.ac.at (Karl Rupp) Date: Wed, 29 Aug 2018 06:34:23 +0200 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> Message-ID: <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> Hi Manuel, as Barry said, it is hard for us to provide any help without having a more complete picture of what is going on. The error you report seems to come from the AMG preconditioner in ViennaCL. This can have many origins. Do other preconditioners run without error? Can you run in a debugger and provide a complete backtrace? Thanks and best regards, Karli On 08/29/2018 01:33 AM, Manuel Valera wrote: > Talked too fast, > > After fixing that problem, i tried more than one mpi processor and got > the following: > > ?Matrix type: mpiaijviennacl > ?Of sizes:? ? ? ? ? 125 x? ? ? ? ?125 > ?Matrix type: mpiaijviennacl > ?Of sizes:? ? ? ? ? 125 x? ? ? ? ?125 > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Currently only handles ViennaCL matrices > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53? GIT > Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue > Aug 28 16:30:02 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 > --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > /home/valera/petsc/src/ksp/pc/interface/precon.c > [1]PETSC ERROR: > ------------------------------------------------------------------------ > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > probably memory access out of range > [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] PetscTraceBackErrorHandler line 182 > /home/valera/petsc/src/sys/error/errtrace.c > [1]PETSC ERROR: [1] PetscError line 352 > /home/valera/petsc/src/sys/error/err.c > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [1]PETSC ERROR: [1] PCSetUp line 894 > /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53? GIT > Date: 2018-05-31 17:31:13 +0300 > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue > Aug 28 16:30:02 2018 > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 > --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > [1]PETSC ERROR: #1 User provided function() line 0 in? unknown file > -------------------------------------------------------------------------- > MPI_ABORT was invoked on rank 1 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. > -------------------------------------------------------------------------- > [0]PETSC ERROR: > ------------------------------------------------------------------------ > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the > batch system) has told this process to end > [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. > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 > /home/valera/petsc/src/sys/objects/tagm.c > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 > /home/valera/petsc/src/sys/objects/inherit.c > [0]PETSC ERROR: [0] ISCreate line 35 > /home/valera/petsc/src/vec/is/is/interface/isreg.c > [0]PETSC ERROR: [0] ISCreateGeneral line 668 > /home/valera/petsc/src/vec/is/is/impls/general/general.c > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [0]PETSC ERROR: [0] PCSetUp line 894 > /home/valera/petsc/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: Signal received > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53? GIT > Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue > Aug 28 16:30:02 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 > --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > [0]PETSC ERROR: #3 User provided function() line 0 in? unknown file > [node50:30582] 1 more process has sent help message help-mpi-api.txt / > mpi-abort > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to see > all help / error messages > > > > It is currently running in 1 mpi processor + GPU but i would like to > call at least 16 mpi processors + GPU to do the rest of the data > management who is not part of the main laplacian on the mpi and the > laplacian solution on the GPU, is this currently possible? > > Thanks for your help, > > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > wrote: > > Ok, i found the culprit and we can close this thread, > > The problem was a missing variable for setting the maximum columns, > which i deleted at some point without realizing. The error message > was too ambiguous to catch this so i had to compare with a previous > working version of the arguments of MatSetValues, it was evident then. > > Good news is that i can now set the values with the viennacl types too, > > Thanks for your kind help, > > Manuel > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. > > wrote: > > > ? ?1) PetscMalloc() is never valid or needed in Fortran > > ? ? 2) there is no reason to use DMSetMatrixPreallocateOnly() > just use DMCreateMatrix() assuming that using a DM (DMDA, > DMPLEX, etc) is suitable for your problem. > > ? ? At this end we are totally guessing at what you are doing > and so have little help we can provide.? A simple, nonworking > code that tries to do what you would need would help us a great > deal in understanding that you are trying to do. > > ? ? ?Barry > > > > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera > > wrote: > > > > Matthew, PetscMalloc gives the same error, > > > > Barry, it would be very hard for me to get the code to a > minimum working example, i guess all i need to understand is how > to setup a DM matrix with DMSetMatrixPreallocateOnly() instead > of MatMPIAIJSetPreallocation() as we were doing before, is there > a simple example who does this in Fortran? > > > > Is the PetscMalloc call needed? is 'call > PetscMalloc(1,row,ierr)' a valid, compilable call to > PetscMalloc? what other reason may there be for this error to > happen ? > > > > Just remembering, that trying to setup the matrix with the > MatAIJSetPreallocation() brings up an error to acknowledge the > viennacl datatypes and that's why i'm trying to make this change > on your recommendation, > > > > Thanks for your help, > > > > > > > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. > > wrote: > > > >? ? Send your code in a way we can compile and run it; it must > be some simple issue that is hard to communicate in email. > > > >? ? Barry > > > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera > > wrote: > > > > > > Hello everyone, > > > > > > I just had time to work on this again, and checked the code > for errors on the matrix entries, this is the exact code i was > using for creating the matrix without > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and > it worked that way, but trying this way i get the same 'Column > too large' error using any number at the column position of > MatSetValues, > > > > > > I have set up my code to print the column argument (n) of > MatSetValues and in this case is 7 (lower than 124), it still > gives error, even entering a specific number in the MatSetValues > column argument position gives the same error. > > > > > > So next i went back to ex.50 here: > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html > > and it has a very similar structure except the PetscMalloc1() > call, so i tried adding that and got: > > > > > >? /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined > reference to `petscmalloc1_' > > > > > > Any ideas on this behaviour? > > > > > > Thanks so much, > > > > > > > > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > > wrote: > > > > > > Column too large: col 10980 max 124 > > > > > >? ? You need to check the code that is generating the matrix > entries. The matrix has 124 columns but you are attempting to > put a value at column 10980 > > > > > >? ? Barry > > > > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera > > wrote: > > > > > > > > Thanks Matthew and Barry, > > > > > > > > Now my code looks like: > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > call MatSetFromOptions(A,ierr) > > > > call MatSetUp(A,ierr) > > > > [...] > > > >? ? ? ? ? ? ?call > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > [...] > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > And i get a different error, now is: > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > [0]PETSC ERROR: Argument out of range > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > > [0]PETSC ERROR: See > http://www.mcs.anl.gov/petsc/documentation/faq.html > for > trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: > v3.9.2-549-g779ab53? GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 > by valera Wed Aug 15 19:40:00 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > > wrote: > > > > > > > >? ?Should be > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > >? ?and remove the rest. You need to set the type of Mat > you want the DM to return BEFORE you create the matrix. > > > > > > > >? ?Barry > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera > > wrote: > > > > > > > > > > Ok thanks for clarifying that, i wasn't sure if there > were different types, > > > > > > > > > > Here is a stripped down version of my code, it seems > like the preallocation is working now since the matrix > population part is working without problem, but here it is for > illustration purposes: > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > call MatSetFromOptions(A,ierr) > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > call > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > call MatSetUp(A,ierr) > > > > > [...] > > > > >? ? ? ? ? ? ?call > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > [...] > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > Adding the first line there did the trick, > > > > > > > > > > Now the problem seems to be the program is not > recognizing the matrix as ViennaCL type when i try with more > than one processor, i get now: > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > > [0]PETSC ERROR: No support for this operation for this > object type > > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > > [0]PETSC ERROR: See > http://www.mcs.anl.gov/petsc/documentation/faq.html > for > trouble shooting. > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > v3.9.2-549-g779ab53? GIT Date: 2018-05-31 17:31:13 +0300 > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > node50 by valera Wed Aug 15 14:44:22 2018 > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > > > When running with: > > > > > > > > > > mpirun -n 1 ./gcmLEP.GPU > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > > wrote: > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > > wrote: > > > > > It seems to be resumed on: I do not know how to > preallocate a DM Matrix correctly. > > > > > > > > > > There is only one matrix type, Mat. There are no > separate DM matrices. A DM can create a matrix for you > > > > > using DMCreateMatrix(), but that is a Mat and it is > preallocated correctly. I am not sure what you are doing. > > > > > > > > > >? ?Thanks, > > > > > > > > > >? ? ?Matt > > > > > > > > > > The interesting part is that it only breaks when i need > to populate a GPU matrix from MPI, so kudos on that, but it > seems i need to do better on my code to get this setup working, > > > > > > > > > > Any help would be appreciated, > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > > wrote: > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > > wrote: > > > > > Thanks Matthew, > > > > > > > > > > I try to do that when calling: > > > > > > > > > > call > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > > > But i am not aware on how to do this for the DM if it > needs something more specific/different, > > > > > > > > > > The error says that your preallocation is wrong for the > values you are putting in. The DM does not control either, > > > > > so I do not understand your email. > > > > > > > > > >? ?Thanks, > > > > > > > > > >? ? ? Matt > > > > > > > > > > Thanks, > > > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > > wrote: > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > > wrote: > > > > > Hello PETSc devs, > > > > > > > > > > I am running into an error when trying to use the > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs > for MATSEQAIJVIENNACL type in one processor. The error happens > when calling MatSetValues for this specific configuration. It > does not occur when using MPI DMMatrix types only. > > > > > > > > > > The DM properly preallocates the matrix. I am assuming > you do not here. > > > > > > > > > >? ? Matt > > > > > > > > > > Any help will be appreciated, > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > My program call: > > > > > > > > > > mpirun -n 2 ./gcmLEP.GPU > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > > > [1]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > > [1]PETSC ERROR: Argument out of range > > > > > [1]PETSC ERROR: Inserting a new nonzero at global > row/column (75, 50) into matrix > > > > > [1]PETSC ERROR: See > http://www.mcs.anl.gov/petsc/documentation/faq.html > for > trouble shooting. > > > > > [1]PETSC ERROR: Petsc Development GIT revision: > v3.9.2-549-g779ab53? GIT Date: 2018-05-31 17:31:13 +0300 > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > node50 by valera Wed Aug 15 13:10:44 2018 > > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > My Code structure: > > > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > call MatSetFromOptions(A,ierr) > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > > > if (numprocs > 1) then? ! set matrix type parallel > > > > >? ? ?! Get local size > > > > >? ? ?call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > > >? ? ?call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > >? ? ?call VecDestroy(Tmpnat,ierr) > > > > >? ? ?! Set matrix > > > > > #ifdef GPU > > > > >? ? ?call MatSetType(A,MATAIJVIENNACL,ierr) > > > > >? ? ?call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > >? ? ?call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > >? ? ?print*,'SETTING GPU TYPES' > > > > > #else > > > > >? ? ?call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > >? ? ?call DMSetMatType(daDummy,VECMPI,ierr) > > > > >? ? ?call MatSetType(A,MATMPIAIJ,ierr)! > > > > > #endif > > > > >? ? ?call > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > else? ? ? ? ? ? ? ? ? ? ! set matrix type sequential > > > > > #ifdef GPU > > > > >? ? ?call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > > >? ? ?call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > >? ? ?call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > >? ? ?print*,'SETTING GPU TYPES' > > > > > #else > > > > >? ? ?call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > >? ? ?call DMSetMatType(daDummy,VECSEQ,ierr) > > > > >? ? ?call MatSetType(A,MATSEQAIJ,ierr) > > > > > #endif > > > > > call MatSetUp(A,ierr) > > > > > call > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > > > do k=zstart,zend-1 > > > > >? ? ?do j=ystart,yend-1 > > > > >? ? ? ? ?do i=xstart,xend-1 > > > > > [..] > > > > >? ? ? ? ? ? call > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > 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 > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > -- > > > > > 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 > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > -- > > > > > 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 > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > From arkhazali at cc.iut.ac.ir Wed Aug 29 04:27:19 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Wed, 29 Aug 2018 13:57:19 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> Message-ID: <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> Barry, Thanks a lot for your efforts. Using PCVPBJACOBI causes SNESSolve to throw the following error (the code and the system being simulated is the same, just PCBJACOBI changed to PCVPBJACOBI): [0]PETSC ERROR: --------------------- Error Message --------------------------------------- ----------------------- [0]PETSC ERROR: Nonconforming object sizes [0]PETSC ERROR: Total blocksizes 0 doesn't match number matrix rows 108000 [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5? GIT Date: 2018-08-28 19:19:26 -0500 [0]PETSC ERROR: E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a? named ALIREZA-PC by AliReza Wed Aug 29 13:46:38 2018 [0]PETSC ERROR: Configure options --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl -- with-hypre-include=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos -master/Bins/include --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdri ve/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/ windows/mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debuggin g=0 --with-blas-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_ x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 - Qopenmp" [0]PETSC ERROR: #1 MatInvertVariableBlockDiagonal_SeqAIJ() line 1569 in E:\cygwin64\home\alireza\PETSc\src\mat\impls\aij\seq\aij.c [0]PETSC ERROR: #2 MatInvertVariableBlockDiagonal() line 10482 in E:\cygwin64\home\alireza\PETSc\src\mat\interface\matrix.c [0]PETSC ERROR: #3 PCSetUp_VPBJacobi() line 120 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\impls\vpbjacobi\vpbjacobi.c [0]PETSC ERROR: #4 PCSetUp() line 932 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\interface\precon.c [0]PETSC ERROR: #5 KSPSetUp() line 381 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c [0]PETSC ERROR: #6 KSPSolve() line 612 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c [0]PETSC ERROR: #7 SNESSolve_NEWTONLS() line 224 in E:\cygwin64\home\alireza\PETSc\src\snes\impls\ls\ls.c [0]PETSC ERROR: #8 SNESSolve() line 4355 in E:\cygwin64\home\alireza\PETSc\src\snes\interface\snes.c Many thanks, Ali On 8/29/2018 2:24 AM, Smith, Barry F. wrote: > Ali, > > In the branch barry/feature-PCVPBJACOBI (see src/snes/examples/tutorials/ex5.c) I have implemented PCVPBJACOBI that is a point block Jacobi with variable size blocks. It has very little testing. > > Could you please try your code with it; you should see very very similar convergence history with this branch and the previous approach you used (the only numerical difference between the two approaches is that this one uses a dense LU factorization for each small block while the previous used a sparse factorization). This new one should also be slightly faster in the KSPSolve(). > > Thanks > > Barry > > > > >> On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: >> >> "Smith, Barry F." writes: >> >>> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c >> Note that this example is block Jacobi with O(1) sparse blocks per >> process, not variable-sized point-block Jacobi which I think is what Ali >> had in mind. >> >>> Please let us know if it works for you and if you have any questions or problems. >>> >>> Barry >>> >>> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >>> >>> Sorry for the runaround with so many emails. >>> >>> >>>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>>> >>>> Hi, >>>> >>>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>>> >>>> Below is a part of my code. It is run serially. Any help is much appreciated. >>>> >>>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>>> CHKERRQ(ierr); >>>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>>> CHKERRQ(ierr); >>>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>>> CHKERRQ(ierr); >>>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>>> CHKERRQ(ierr); >>>> ierr = SNESSetType(snes, SNESNEWTONLS); >>>> CHKERRQ(ierr); >>>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>>> CHKERRQ(ierr); >>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>> CHKERRQ(ierr); >>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>> CHKERRQ(ierr); >>>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>>> CHKERRQ(ierr); >>>> >>>> SNESSetUp(snes); >>>> CHKERRQ(ierr); >>>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>>> CHKERRQ(ierr); >>>> >>>> for (i = 0; i < nLocal; i++) { >>>> ierr = KSPGetPC(subKSP[i], &SubPc); >>>> CHKERRQ(ierr); >>>> ierr = PCSetType(SubPc, PCLU); >>>> CHKERRQ(ierr); >>>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>>> CHKERRQ(ierr); >>>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>>> CHKERRQ(ierr); >>>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>>> CHKERRQ(ierr); >>>> } >>>> ierr = SNESSolve(snes, NULL, Petsc_X); >>>> CHKERRQ(ierr); >>>> >>>> >>>> >>>> -- >>>> Ali Reza Khaz?ali >>>> Assistant Professor of Petroleum Engineering, >>>> Department of Chemical Engineering >>>> Isfahan University of Technology >>>> Isfahan, Iran >>>> -- Ali Reza Khaz?ali Assistant Professor of Petroleum Engineering, Department of Chemical Engineering Isfahan University of Technology Isfahan, Iran From srahul_05 at yahoo.co.in Wed Aug 29 09:36:58 2018 From: srahul_05 at yahoo.co.in (Rahul Samala) Date: Wed, 29 Aug 2018 14:36:58 +0000 (UTC) Subject: [petsc-users] Problem with SNES convergence References: <1371398831.496454.1535553418412.ref@mail.yahoo.com> Message-ID: <1371398831.496454.1535553418412@mail.yahoo.com> Hello PetSc users, 1)? I have problem with SNES convergence. I call SNESSolve? in a time loop and use the inbuilt Jacobian feature. The code works fine for about 5380 time steps after which it breaks down. The solution till that point looks fine. I have used newtonls of type l2. (newtontr and others aren't working). Since I have used inbuilt Jacobian feature and the code worked for about 5000 time steps I don't understand the reason for failure, is it an incorrect function evaluation?? Attached are the outputs with -pc_type lu and ilu along with -snes_linesearch_type l2 -snes_converged_reason -snes_monitor -snes_view -ksp_converged_reason -ksp_monitor_true_residual 2)? How to get hold of failure signal, like Nonlinear solve DIVERGED_MAX_IT or DIVERGED_LINEAR_SOLVE so that whenever it occurs I can use a reduced time step and see if the code converges. Thank you,Rahul. output_ilu.txt | | | | | | | | | | | output_ilu.txt | | | output_lu.txt | | | | | | | | | | | output_lu.txt | | | -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 29 10:10:12 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 29 Aug 2018 15:10:12 +0000 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> Message-ID: You need to add the line ierr = MatSetVariableBlockSizes(J,3,lens);CHKERRQ(ierr); with the number of blocks replacing 3 and the sizes of each block in lens Barry > On Aug 29, 2018, at 4:27 AM, Ali Reza Khaz'ali wrote: > > Barry, > > Thanks a lot for your efforts. Using PCVPBJACOBI causes SNESSolve to throw the following error (the code and the system being simulated is the same, just PCBJACOBI changed to PCVPBJACOBI): > > > [0]PETSC ERROR: --------------------- Error Message --------------------------------------- > ----------------------- > [0]PETSC ERROR: Nonconforming object sizes > [0]PETSC ERROR: Total blocksizes 0 doesn't match number matrix rows 108000 > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5 GIT Date: 2018-08-28 19:19:26 -0500 > [0]PETSC ERROR: E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a named ALIREZA-PC by AliReza Wed Aug 29 13:46:38 2018 > [0]PETSC ERROR: Configure options --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl -- > with-hypre-include=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos > -master/Bins/include --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdri > ve/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/ > windows/mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debuggin > g=0 --with-blas-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_ > x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 - > Qopenmp" > [0]PETSC ERROR: #1 MatInvertVariableBlockDiagonal_SeqAIJ() line 1569 in E:\cygwin64\home\alireza\PETSc\src\mat\impls\aij\seq\aij.c > [0]PETSC ERROR: #2 MatInvertVariableBlockDiagonal() line 10482 in E:\cygwin64\home\alireza\PETSc\src\mat\interface\matrix.c > [0]PETSC ERROR: #3 PCSetUp_VPBJacobi() line 120 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\impls\vpbjacobi\vpbjacobi.c > [0]PETSC ERROR: #4 PCSetUp() line 932 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\interface\precon.c > [0]PETSC ERROR: #5 KSPSetUp() line 381 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c > [0]PETSC ERROR: #6 KSPSolve() line 612 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c > [0]PETSC ERROR: #7 SNESSolve_NEWTONLS() line 224 in E:\cygwin64\home\alireza\PETSc\src\snes\impls\ls\ls.c > [0]PETSC ERROR: #8 SNESSolve() line 4355 in E:\cygwin64\home\alireza\PETSc\src\snes\interface\snes.c > > Many thanks, > Ali > > On 8/29/2018 2:24 AM, Smith, Barry F. wrote: >> Ali, >> >> In the branch barry/feature-PCVPBJACOBI (see src/snes/examples/tutorials/ex5.c) I have implemented PCVPBJACOBI that is a point block Jacobi with variable size blocks. It has very little testing. >> >> Could you please try your code with it; you should see very very similar convergence history with this branch and the previous approach you used (the only numerical difference between the two approaches is that this one uses a dense LU factorization for each small block while the previous used a sparse factorization). This new one should also be slightly faster in the KSPSolve(). >> >> Thanks >> >> Barry >> >> >> >> >>> On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: >>> >>> "Smith, Barry F." writes: >>> >>>> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c >>> Note that this example is block Jacobi with O(1) sparse blocks per >>> process, not variable-sized point-block Jacobi which I think is what Ali >>> had in mind. >>> >>>> Please let us know if it works for you and if you have any questions or problems. >>>> >>>> Barry >>>> >>>> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >>>> >>>> Sorry for the runaround with so many emails. >>>> >>>> >>>>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>>>> >>>>> Hi, >>>>> >>>>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>>>> >>>>> Below is a part of my code. It is run serially. Any help is much appreciated. >>>>> >>>>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>>>> CHKERRQ(ierr); >>>>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>>>> CHKERRQ(ierr); >>>>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>>>> CHKERRQ(ierr); >>>>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>>>> CHKERRQ(ierr); >>>>> ierr = SNESSetType(snes, SNESNEWTONLS); >>>>> CHKERRQ(ierr); >>>>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>>>> CHKERRQ(ierr); >>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>> CHKERRQ(ierr); >>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>> CHKERRQ(ierr); >>>>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>>>> CHKERRQ(ierr); >>>>> >>>>> SNESSetUp(snes); >>>>> CHKERRQ(ierr); >>>>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>>>> CHKERRQ(ierr); >>>>> >>>>> for (i = 0; i < nLocal; i++) { >>>>> ierr = KSPGetPC(subKSP[i], &SubPc); >>>>> CHKERRQ(ierr); >>>>> ierr = PCSetType(SubPc, PCLU); >>>>> CHKERRQ(ierr); >>>>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>>>> CHKERRQ(ierr); >>>>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>>>> CHKERRQ(ierr); >>>>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>>>> CHKERRQ(ierr); >>>>> } >>>>> ierr = SNESSolve(snes, NULL, Petsc_X); >>>>> CHKERRQ(ierr); >>>>> >>>>> >>>>> >>>>> -- >>>>> Ali Reza Khaz?ali >>>>> Assistant Professor of Petroleum Engineering, >>>>> Department of Chemical Engineering >>>>> Isfahan University of Technology >>>>> Isfahan, Iran >>>>> > > -- > Ali Reza Khaz?ali > Assistant Professor of Petroleum Engineering, > Department of Chemical Engineering > Isfahan University of Technology > Isfahan, Iran > From Ling.Zou at inl.gov Wed Aug 29 10:11:04 2018 From: Ling.Zou at inl.gov (Ling Zou) Date: Wed, 29 Aug 2018 15:11:04 +0000 Subject: [petsc-users] Problem with SNES convergence In-Reply-To: <1371398831.496454.1535553418412@mail.yahoo.com> References: <1371398831.496454.1535553418412.ref@mail.yahoo.com>, <1371398831.496454.1535553418412@mail.yahoo.com> Message-ID: 1) My experience is that this kind of bug or sudden death (everything is fine till suddenly something is broken) is very difficult to debug/fix. I looked at your txt files and could not give any quick comments. Maybe PETSc developers have better idea on this. 2) I do have successful experience on reducing time step size when PETSc fails solving or my own piece of code throws an exception. If you are interested, I can share them. -Ling ________________________________ From: petsc-users on behalf of Rahul Samala Sent: Wednesday, August 29, 2018 8:36:58 AM To: PETSc Users List Subject: [petsc-users] Problem with SNES convergence Hello PetSc users, 1) I have problem with SNES convergence. I call SNESSolve in a time loop and use the inbuilt Jacobian feature. The code works fine for about 5380 time steps after which it breaks down. The solution till that point looks fine. I have used newtonls of type l2. (newtontr and others aren't working). Since I have used inbuilt Jacobian feature and the code worked for about 5000 time steps I don't understand the reason for failure, is it an incorrect function evaluation? Attached are the outputs with -pc_type lu and ilu along with -snes_linesearch_type l2 -snes_converged_reason -snes_monitor -snes_view -ksp_converged_reason -ksp_monitor_true_residual 2) How to get hold of failure signal, like Nonlinear solve DIVERGED_MAX_IT or DIVERGED_LINEAR_SOLVE so that whenever it occurs I can use a reduced time step and see if the code converges. Thank you, Rahul. output_ilu.txt [https://s.yimg.com/nq/storm/assets/enhancrV2/23/logos/google.png] output_ilu.txt output_lu.txt [https://s.yimg.com/nq/storm/assets/enhancrV2/23/logos/google.png] output_lu.txt -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 29 10:31:54 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 29 Aug 2018 15:31:54 +0000 Subject: [petsc-users] Problem with SNES convergence In-Reply-To: References: <1371398831.496454.1535553418412.ref@mail.yahoo.com> <1371398831.496454.1535553418412@mail.yahoo.com> Message-ID: <387994F6-79FF-4DE4-8375-B24F63B0F332@anl.gov> Current time (before start of timestep) 52.5048, iter=5380 Timestep=864.000000 0 SNES Function norm 1.650467412595e+05 0 KSP preconditioned resid norm 3.979123221160e+03 true resid norm 1.650467412595e+05 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 9.178246525982e-11 true resid norm 7.006473307032e-09 ||r(i)||/||b|| 4.245144892632e-14 Linear solve converged due to CONVERGED_RTOL iterations 1 1 SNES Function norm 6.722712947273e+02 Linear solve did not converge due to DIVERGED_NANORINF iterations 0 Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 1 This usually is an indicator that the LU (ILU) factorization has hit a zero pivot (hence the linear solve has a divide by zero so gives the DIVERGED_NANORINF flag). You can/should call SNESGetConvergedReason() immediately after each SNESSolve(), if the result is negative that means something has failed in the nonlinear solve and you can try cutting the time-step and trying again. Good luck, Barry > On Aug 29, 2018, at 10:11 AM, Ling Zou wrote: > > 1) My experience is that this kind of bug or sudden death (everything is fine till suddenly something is broken) is very difficult to debug/fix. I looked at your txt files and could not give any quick comments. Maybe PETSc developers have better idea on this. > 2) I do have successful experience on reducing time step size when PETSc fails solving or my own piece of code throws an exception. If you are interested, I can share them. > > -Ling > From: petsc-users on behalf of Rahul Samala > Sent: Wednesday, August 29, 2018 8:36:58 AM > To: PETSc Users List > Subject: [petsc-users] Problem with SNES convergence > > Hello PetSc users, > > 1) I have problem with SNES convergence. I call SNESSolve in a time loop and use the inbuilt Jacobian feature. The code works fine for about 5380 time steps after which it breaks down. The solution till that point looks fine. I have used newtonls of type l2. (newtontr and others aren't working). Since I have used inbuilt Jacobian feature and the code worked for about 5000 time steps I don't understand the reason for failure, is it an incorrect function evaluation? Attached are the outputs with -pc_type lu and ilu along with -snes_linesearch_type l2 -snes_converged_reason -snes_monitor -snes_view -ksp_converged_reason -ksp_monitor_true_residual > > 2) How to get hold of failure signal, like Nonlinear solve DIVERGED_MAX_IT or DIVERGED_LINEAR_SOLVE so that whenever it occurs I can use a reduced time step and see if the code converges. > > Thank you, > Rahul. > > output_ilu.txt > > > output_ilu.txt > > > > output_lu.txt > > > output_lu.txt From justin_dong at brown.edu Wed Aug 29 11:09:55 2018 From: justin_dong at brown.edu (Justin Dong) Date: Wed, 29 Aug 2018 12:09:55 -0400 Subject: [petsc-users] C++ Makefile for PETSc program Message-ID: Hi all, I have a program with C++ that I am trying to integrate with PETSc on MacOS X. My Makefile looks like this #-----[Makefile]------ > include ${PETSC_DIR}/lib/petsc/conf/variables > include ${PETSC_DIR}/lib/petsc/conf/rules > include ${PETSC_DIR}/lib/petsc/conf/test > > #----[Directories]---- > oPath = obj > sPath = src > iPath = inc $(PETSC_LIB) > #==================== > > #---[Compiler and Settings]----- > compiler = g++-8 > compilerFlags = -std=c++11 -Wall -lm -llapack -lblas -O3 > paths = -I./$(iPath) > #====================== > > #----[Variable Names]------- > headers = $(wildcard $(iPath)/*.hpp) > sources = $(wildcard $(sPath)/*.cpp) > objects = $(subst $(sPath)/,$(oPath)/,$(sources:.cpp=.o)) > #========================== > > #----[Compilation]--------- > main:$(objects) $(headers) main.cpp > $(compiler) $(compilerFlags) -o main $(objects) main.cpp $(PETSC_LIB) > $(paths) > $(oPath)/%.o:$(sPath)/%.cpp $(subst $(sPath)/, $(iPath)/,$(<:.cpp=.hpp)) > @mkdir -p $(@D) > $(compiler) $(compilerFlags) -o $@ -c $(paths) $< > > #-----[Clean up]------- > # clean:rm main > # rm -rf $(oPath)/ When I try to include "petsc.h", I get a "no such file or directory" error. I have PETSC_DIR and PETSC_ARCH set correctly, but I'm not the most proficient with Make. Can someone provide some tips on how to get this working properly? Best, Justin -------------- next part -------------- An HTML attachment was scrubbed... URL: From arkhazali at cc.iut.ac.ir Wed Aug 29 11:26:03 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Wed, 29 Aug 2018 20:56:03 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> Message-ID: <5eb8cbb3-f215-3ed2-b373-5bcbfbc5d29d@cc.iut.ac.ir> Barry, Thank you very much. I placed MatSetVariableBlockSizes after Jacobian assembly and/or before SNESSolve. In both cases, It could not solve a 30x30x10 system (which has been solved before), apparently because of the huge amount of RAM it required (~3GB). I don't have a lot of RAM on my laptop (I only have 4GB). The log output is as follows, please note that the number of blocks of the bjacobi preconditioner is reported as 1, which I think it means that it has tried to solve the whole Jacobian matrix with the direct method. If it is true, the amount of required RAM is justified. However, the same code can successfully solve a smaller system (10x10x5 for example). Best regards, Ali On 8/29/2018 7:40 PM, Smith, Barry F. wrote: > You need to add the line > > ierr = MatSetVariableBlockSizes(J,3,lens);CHKERRQ(ierr); > > with the number of blocks replacing 3 and the sizes of each block in lens > > Barry > > >> On Aug 29, 2018, at 4:27 AM, Ali Reza Khaz'ali wrote: >> >> Barry, >> >> Thanks a lot for your efforts. Using PCVPBJACOBI causes SNESSolve to throw the following error (the code and the system being simulated is the same, just PCBJACOBI changed to PCVPBJACOBI): >> >> >> [0]PETSC ERROR: --------------------- Error Message --------------------------------------- >> ----------------------- >> [0]PETSC ERROR: Nonconforming object sizes >> [0]PETSC ERROR: Total blocksizes 0 doesn't match number matrix rows 108000 >> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5 GIT Date: 2018-08-28 19:19:26 -0500 >> [0]PETSC ERROR: E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a named ALIREZA-PC by AliReza Wed Aug 29 13:46:38 2018 >> [0]PETSC ERROR: Configure options --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl -- >> with-hypre-include=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos >> -master/Bins/include --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdri >> ve/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/ >> windows/mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debuggin >> g=0 --with-blas-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_ >> x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 - >> Qopenmp" >> [0]PETSC ERROR: #1 MatInvertVariableBlockDiagonal_SeqAIJ() line 1569 in E:\cygwin64\home\alireza\PETSc\src\mat\impls\aij\seq\aij.c >> [0]PETSC ERROR: #2 MatInvertVariableBlockDiagonal() line 10482 in E:\cygwin64\home\alireza\PETSc\src\mat\interface\matrix.c >> [0]PETSC ERROR: #3 PCSetUp_VPBJacobi() line 120 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\impls\vpbjacobi\vpbjacobi.c >> [0]PETSC ERROR: #4 PCSetUp() line 932 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\interface\precon.c >> [0]PETSC ERROR: #5 KSPSetUp() line 381 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >> [0]PETSC ERROR: #6 KSPSolve() line 612 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >> [0]PETSC ERROR: #7 SNESSolve_NEWTONLS() line 224 in E:\cygwin64\home\alireza\PETSc\src\snes\impls\ls\ls.c >> [0]PETSC ERROR: #8 SNESSolve() line 4355 in E:\cygwin64\home\alireza\PETSc\src\snes\interface\snes.c >> >> Many thanks, >> Ali >> >> On 8/29/2018 2:24 AM, Smith, Barry F. wrote: >>> Ali, >>> >>> In the branch barry/feature-PCVPBJACOBI (see src/snes/examples/tutorials/ex5.c) I have implemented PCVPBJACOBI that is a point block Jacobi with variable size blocks. It has very little testing. >>> >>> Could you please try your code with it; you should see very very similar convergence history with this branch and the previous approach you used (the only numerical difference between the two approaches is that this one uses a dense LU factorization for each small block while the previous used a sparse factorization). This new one should also be slightly faster in the KSPSolve(). >>> >>> Thanks >>> >>> Barry >>> >>> >>> >>> >>>> On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: >>>> >>>> "Smith, Barry F." writes: >>>> >>>>> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c >>>> Note that this example is block Jacobi with O(1) sparse blocks per >>>> process, not variable-sized point-block Jacobi which I think is what Ali >>>> had in mind. >>>> >>>>> Please let us know if it works for you and if you have any questions or problems. >>>>> >>>>> Barry >>>>> >>>>> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >>>>> >>>>> Sorry for the runaround with so many emails. >>>>> >>>>> >>>>>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>>>>> >>>>>> Hi, >>>>>> >>>>>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>>>>> >>>>>> Below is a part of my code. It is run serially. Any help is much appreciated. >>>>>> >>>>>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>>>>> CHKERRQ(ierr); >>>>>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>>>>> CHKERRQ(ierr); >>>>>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>>>>> CHKERRQ(ierr); >>>>>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>>>>> CHKERRQ(ierr); >>>>>> ierr = SNESSetType(snes, SNESNEWTONLS); >>>>>> CHKERRQ(ierr); >>>>>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>>>>> CHKERRQ(ierr); >>>>>> >>>>>> SNESSetUp(snes); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>>>>> CHKERRQ(ierr); >>>>>> >>>>>> for (i = 0; i < nLocal; i++) { >>>>>> ierr = KSPGetPC(subKSP[i], &SubPc); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCSetType(SubPc, PCLU); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>>>>> CHKERRQ(ierr); >>>>>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>>>>> CHKERRQ(ierr); >>>>>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>>>>> CHKERRQ(ierr); >>>>>> } >>>>>> ierr = SNESSolve(snes, NULL, Petsc_X); >>>>>> CHKERRQ(ierr); >>>>>> >>>>>> From arkhazali at cc.iut.ac.ir Wed Aug 29 12:43:08 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Wed, 29 Aug 2018 22:13:08 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> Message-ID: <7b093784-8da8-1b00-9f31-a327d86882ab@cc.iut.ac.ir> I noticed that I forgot to include the log for 10x10x5 system. Here it is: 1 MPI processes ? type: newtonls ? maximum iterations=2000, maximum function evaluations=2000 ? tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 ? total number of linear solver iterations=1 ? total number of function evaluations=2 ? norm schedule ALWAYS ? SNESLineSearch Object: 1 MPI processes ??? type: bt ????? interpolation: cubic ????? alpha=1.000000e-04 ??? maxstep=1.000000e+08, minlambda=1.000000e-12 ??? tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 ??? maximum iterations=40 ? KSP Object: 1 MPI processes ??? type: gmres ????? restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement ????? happy breakdown tolerance 1e-30 ??? maximum iterations=5000, initial guess is zero ??? tolerances:? relative=1e-05, absolute=1e-06, divergence=10000. ??? left preconditioning ??? using PRECONDITIONED norm type for convergence test ? PC Object: 1 MPI processes ??? type: bjacobi ????? number of blocks = 1 ????? Local solve is same for all blocks, in the following KSP and PC objects: ????? KSP Object: (sub_) 1 MPI processes ??????? type: preonly ??????? maximum iterations=10000, initial guess is zero ??????? tolerances:? relative=1e-05, absolute=1e-50, divergence=10000. ??????? left preconditioning ??????? using NONE norm type for convergence test ????? PC Object: (sub_) 1 MPI processes ??????? type: lu ????????? out-of-place factorization ????????? tolerance for zero pivot 2.22045e-14 ????????? matrix ordering: nd ????????? factor fill ratio given 0., needed 0. ??????????? Factored matrix follows: ????????????? Mat Object: 1 MPI processes ??????????????? type: mkl_pardiso ??????????????? rows=6000, cols=6000 ??????????????? package used to perform factorization: mkl_pardiso ??????????????? total: nonzeros=150000, allocated nonzeros=150000 ??????????????? total number of mallocs used during MatSetValues calls =0 ????????????????? MKL_PARDISO run parameters: ????????????????? MKL_PARDISO phase:???????????? 33 ????????????????? MKL_PARDISO iparm[1]:???? 1 ????????????????? MKL_PARDISO iparm[2]:???? 2 ????????????????? MKL_PARDISO iparm[3]:???? 2 ????????????????? MKL_PARDISO iparm[4]:???? 0 ????????????????? MKL_PARDISO iparm[5]:???? 0 ????????????????? MKL_PARDISO iparm[6]:???? 0 ????????????????? MKL_PARDISO iparm[7]:???? 0 ????????????????? MKL_PARDISO iparm[8]:???? 0 ????????????????? MKL_PARDISO iparm[9]:???? 0 ????????????????? MKL_PARDISO iparm[10]:???? 13 ????????????????? MKL_PARDISO iparm[11]:???? 1 ????????????????? MKL_PARDISO iparm[12]:???? 0 ????????????????? MKL_PARDISO iparm[13]:???? 1 ????????????????? MKL_PARDISO iparm[14]:???? 0 ????????????????? MKL_PARDISO iparm[15]:???? 11228 ????????????????? MKL_PARDISO iparm[16]:???? 7563 ????????????????? MKL_PARDISO iparm[17]:???? 37035 ????????????????? MKL_PARDISO iparm[18]:???? 4204238 ????????????????? MKL_PARDISO iparm[19]:???? 2659 ????????????????? MKL_PARDISO iparm[20]:???? 0 ????????????????? MKL_PARDISO iparm[21]:???? 0 ????????????????? MKL_PARDISO iparm[22]:???? 0 ????????????????? MKL_PARDISO iparm[23]:???? 0 ????????????????? MKL_PARDISO iparm[24]:???? 0 ????????????????? MKL_PARDISO iparm[25]:???? 0 ????????????????? MKL_PARDISO iparm[26]:???? 0 ????????????????? MKL_PARDISO iparm[27]:???? 0 ????????????????? MKL_PARDISO iparm[28]:???? 0 ????????????????? MKL_PARDISO iparm[29]:???? 0 ????????????????? MKL_PARDISO iparm[30]:???? 0 ????????????????? MKL_PARDISO iparm[31]:???? 0 ????????????????? MKL_PARDISO iparm[32]:???? 0 ????????????????? MKL_PARDISO iparm[33]:???? 0 ????????????????? MKL_PARDISO iparm[34]:???? -1 ????????????????? MKL_PARDISO iparm[35]:???? 1 ????????????????? MKL_PARDISO iparm[36]:???? 0 ????????????????? MKL_PARDISO iparm[37]:???? 0 ????????????????? MKL_PARDISO iparm[38]:???? 0 ????????????????? MKL_PARDISO iparm[39]:???? 0 ????????????????? MKL_PARDISO iparm[40]:???? 0 ????????????????? MKL_PARDISO iparm[41]:???? 0 ????????????????? MKL_PARDISO iparm[42]:???? 0 ????????????????? MKL_PARDISO iparm[43]:???? 0 ????????????????? MKL_PARDISO iparm[44]:???? 0 ????????????????? MKL_PARDISO iparm[45]:???? 0 ????????????????? MKL_PARDISO iparm[46]:???? 0 ????????????????? MKL_PARDISO iparm[47]:???? 0 ????????????????? MKL_PARDISO iparm[48]:???? 0 ????????????????? MKL_PARDISO iparm[49]:???? 0 ????????????????? MKL_PARDISO iparm[50]:???? 0 ????????????????? MKL_PARDISO iparm[51]:???? 0 ????????????????? MKL_PARDISO iparm[52]:???? 0 ????????????????? MKL_PARDISO iparm[53]:???? 0 ????????????????? MKL_PARDISO iparm[54]:???? 0 ????????????????? MKL_PARDISO iparm[55]:???? 0 ????????????????? MKL_PARDISO iparm[56]:???? 0 ????????????????? MKL_PARDISO iparm[57]:???? -1 ????????????????? MKL_PARDISO iparm[58]:???? 0 ????????????????? MKL_PARDISO iparm[59]:???? 0 ????????????????? MKL_PARDISO iparm[60]:???? 0 ????????????????? MKL_PARDISO iparm[61]:???? 11228 ????????????????? MKL_PARDISO iparm[62]:???? 7868 ????????????????? MKL_PARDISO iparm[63]:???? 3629 ????????????????? MKL_PARDISO iparm[64]:???? 0 ????????????????? MKL_PARDISO maxfct:???? 1 ????????????????? MKL_PARDISO mnum:???? 1 ????????????????? MKL_PARDISO mtype:???? 11 ????????????????? MKL_PARDISO n:???? 6000 ????????????????? MKL_PARDISO nrhs:???? 1 ????????????????? MKL_PARDISO msglvl:???? 0 ??????? linear system matrix = precond matrix: ??????? Mat Object: 1 MPI processes ????????? type: seqaij ????????? rows=6000, cols=6000 ????????? total: nonzeros=150000, allocated nonzeros=480000 ????????? total number of mallocs used during MatSetValues calls =0 ??????????? not using I-node routines ??? linear system matrix = precond matrix: ??? Mat Object: 1 MPI processes ????? type: seqaij ????? rows=6000, cols=6000 ????? total: nonzeros=150000, allocated nonzeros=480000 ????? total number of mallocs used during MatSetValues calls =0 ??????? not using I-node routines ************************************************************************************************************************ ***???????????? WIDEN YOUR WINDOW TO 120 CHARACTERS.? Use 'enscript -r -fCourier9' to print this document??????????? *** ************************************************************************************************************************ ---------------------------------------------- PETSc Performance Summary: ---------------------------------------------- E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a? named ALIREZA-PC with 1 processor, by AliReza Wed Aug 29 22:12:30 2018 Using Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5? GIT Date: 2018-08-28 19:19:26 -0500 ???????????????????????? Max?????? Max/Min???? Avg?????? Total Time (sec):?????????? 3.373e+01???? 1.000?? 3.373e+01 Objects:????????????? 3.300e+01???? 1.000?? 3.300e+01 Flop:???????????????? 7.500e+05???? 1.000?? 7.500e+05? 7.500e+05 Flop/sec:???????????? 2.224e+04???? 1.000?? 2.224e+04? 2.224e+04 MPI Messages:???????? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 MPI Message Lengths:? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 MPI Reductions:?????? 0.000e+00???? 0.000 Flop counting convention: 1 flop = 1 real number operation of type (multiply/divide/add/subtract) ??????????????????????????? e.g., VecAXPY() for real vectors of length N --> 2N flop ??????????????????????????? and VecAXPY() for complex vectors of length N --> 8N flop Summary of Stages:?? ----- Time ------? ----- Flop ------? --- Messages ---? -- Message Lengths --? -- Reductions -- ??????????????????????? Avg???? %Total???? Avg???? %Total Count?? %Total???? Avg???????? %Total??? Count?? %Total ?0:????? Main Stage: 3.3730e+01 100.0%? 7.5000e+05 100.0% 0.000e+00?? 0.0%? 0.000e+00??????? 0.0%? 0.000e+00?? 0.0% ------------------------------------------------------------------------------------------------------------------------ See the 'Profiling' chapter of the users' manual for details on interpreting output. Phase summary info: ?? Count: number of times phase was executed ?? Time and Flop: Max - maximum over all processors ????????????????? Ratio - ratio of maximum to minimum over all processors ?? Mess: number of messages sent ?? AvgLen: average message length (bytes) ?? Reduct: number of global reductions ?? Global: entire computation ?? Stage: stages of a computation. Set stages with PetscLogStagePush() and PetscLogStagePop(). ????? %T - percent time in this phase???????? %F - percent flop in this phase ????? %M - percent messages in this phase???? %L - percent message lengths in this phase ????? %R - percent reductions in this phase ?? Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time over all processors) ------------------------------------------------------------------------------------------------------------------------ Event??????????????? Count????? Time (sec) Flop????????????????????????????? --- Global ---? --- Stage ---- Total ?????????????????? Max Ratio? Max???? Ratio?? Max? Ratio? Mess AvgLen? Reduct? %T %F %M %L %R? %T %F %M %L %R Mflop/s ------------------------------------------------------------------------------------------------------------------------ --- Event Stage 0: Main Stage BuildTwoSidedF???????? 2 1.0 7.9003e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 SNESSolve????????????? 1 1.0 7.3396e+00 1.0 7.50e+05 1.0 0.0e+00 0.0e+00 0.0e+00 22100? 0? 0? 0? 22100? 0? 0? 0???? 0 SNESFunctionEval?????? 2 1.0 3.8894e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 SNESJacobianEval?????? 1 1.0 5.1611e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 15? 0? 0? 0? 0? 15? 0? 0? 0? 0???? 0 SNESLineSearch???????? 1 1.0 1.7655e-02 1.0 3.60e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0 48? 0? 0? 0?? 0 48? 0? 0? 0??? 20 VecDot???????????????? 1 1.0 1.1546e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 1039 VecMDot??????????????? 1 1.0 2.3093e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0?? 520 VecNorm??????????????? 5 1.0 4.9769e-01 1.0 6.00e+04 1.0 0.0e+00 0.0e+00 0.0e+00? 1? 8? 0? 0? 0?? 1? 8? 0? 0? 0???? 0 VecScale?????????????? 2 1.0 9.3291e-03 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 1 VecCopy??????????????? 3 1.0 2.3093e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecSet???????????????? 4 1.0 1.5395e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecAXPY??????????????? 1 1.0 2.5734e-02 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 0 VecWAXPY?????????????? 1 1.0 1.3257e-05 1.0 6.00e+03 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0?? 453 VecMAXPY?????????????? 2 1.0 2.3521e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0? 1020 VecAssemblyBegin?????? 2 1.0 7.9040e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecAssemblyEnd???????? 2 1.0 1.7961e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecReduceArith???????? 2 1.0 9.8359e-06 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0? 2440 VecReduceComm????????? 1 1.0 4.7041e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecNormalize?????????? 2 1.0 9.3552e-03 1.0 3.60e+04 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0???? 4 MatMult??????????????? 2 1.0 4.4860e-04 1.0 5.88e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0 78? 0? 0? 0?? 0 78? 0? 0? 0? 1311 MatSolve?????????????? 2 1.0 1.7876e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 MatLUFactorSym???????? 1 1.0 7.6157e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 MatLUFactorNum???????? 1 1.0 6.5977e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 MatAssemblyBegin?????? 2 1.0 0.0000e+00 0.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatAssemblyEnd???????? 2 1.0 1.2962e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatGetRowIJ??????????? 1 1.0 1.1534e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatGetOrdering???????? 1 1.0 5.1809e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatZeroEntries???????? 1 1.0 1.1298e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatView??????????????? 3 1.0 3.8344e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 KSPSetUp?????????????? 2 1.0 3.2843e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 KSPSolve?????????????? 1 1.0 1.6414e+00 1.0 3.78e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 5 50? 0? 0? 0?? 5 50? 0? 0? 0???? 0 KSPGMRESOrthog???????? 1 1.0 5.9015e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0?? 407 PCSetUp??????????????? 2 1.0 1.4267e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 PCSetUpOnBlocks??????? 1 1.0 1.4266e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 PCApply??????????????? 2 1.0 1.7882e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 ------------------------------------------------------------------------------------------------------------------------ Memory usage is given in bytes: Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. Reports information only for process 0. --- Event Stage 0: Main Stage ??????????????? SNES???? 1????????????? 0??????????? 0???? 0. ????????????? DMSNES???? 1????????????? 0??????????? 0???? 0. ????? SNESLineSearch???? 1????????????? 0??????????? 0???? 0. ????????????? Vector??? 12????????????? 0??????????? 0???? 0. ????????????? Matrix???? 2????????????? 0??????????? 0???? 0. ??? Distributed Mesh???? 2????????????? 0??????????? 0???? 0. ?????????? Index Set???? 2????????????? 0??????????? 0???? 0. ?? Star Forest Graph???? 4????????????? 0??????????? 0???? 0. ???? Discrete System???? 2????????????? 0??????????? 0???? 0. ?????? Krylov Solver???? 2????????????? 0??????????? 0???? 0. ???? DMKSP interface???? 1????????????? 0??????????? 0???? 0. ????? Preconditioner???? 2????????????? 0??????????? 0???? 0. ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. ======================================================================================================================== Average time to get PetscTime(): 4.27647e-08 #PETSc Option Table entries: -ksp_atol 1e-6 -ksp_rtol 1e-5 -snes_rtol 1e-4 -sub_ksp_type preonly -sub_pc_factor_mat_solver_type mkl_pardiso -sub_pc_type lu #End of PETSc Option Table entries Compiled without FORTRAN kernels Compiled with full precision matrices (default) sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 sizeof(PetscScalar) 8 sizeof(PetscInt) 4 Configure options: --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl --with-hypre-incl ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdrive/E/Program_Fi les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int el64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debugging=0 --with-blas -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 -Qopenmp" ----------------------------------------- Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit Using PETSc directory: /home/alireza/PetscGit Using PETSc arch: ----------------------------------------- Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl -O2 -MT -wd4996 -Qopenmp Using Fortran compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp -fpp ----------------------------------------- Using include paths: -I/home/alireza/PetscGit/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include -I/cygdrive/E/hypre-2.11.2/ Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include ----------------------------------------- Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort Using libraries: -L/home/alireza/PetscGit/lib -L/home/alireza/PetscGit/lib -lpetsc /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib /cygdrive/E/Trilinos-master/Bins/lib /ml.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Gdi32.lib User32.lib ?Advapi32.lib Kernel32.lib Ws2_32.lib ----------------------------------------- On 8/29/2018 7:40 PM, Smith, Barry F. wrote: > You need to add the line > > ierr = MatSetVariableBlockSizes(J,3,lens);CHKERRQ(ierr); > > with the number of blocks replacing 3 and the sizes of each block in lens > > Barry > > >> On Aug 29, 2018, at 4:27 AM, Ali Reza Khaz'ali wrote: >> >> Barry, >> >> Thanks a lot for your efforts. Using PCVPBJACOBI causes SNESSolve to throw the following error (the code and the system being simulated is the same, just PCBJACOBI changed to PCVPBJACOBI): >> >> >> [0]PETSC ERROR: --------------------- Error Message --------------------------------------- >> ----------------------- >> [0]PETSC ERROR: Nonconforming object sizes >> [0]PETSC ERROR: Total blocksizes 0 doesn't match number matrix rows 108000 >> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5 GIT Date: 2018-08-28 19:19:26 -0500 >> [0]PETSC ERROR: E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a named ALIREZA-PC by AliReza Wed Aug 29 13:46:38 2018 >> [0]PETSC ERROR: Configure options --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl -- >> with-hypre-include=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos >> -master/Bins/include --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdri >> ve/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/ >> windows/mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debuggin >> g=0 --with-blas-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_ >> x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 - >> Qopenmp" >> [0]PETSC ERROR: #1 MatInvertVariableBlockDiagonal_SeqAIJ() line 1569 in E:\cygwin64\home\alireza\PETSc\src\mat\impls\aij\seq\aij.c >> [0]PETSC ERROR: #2 MatInvertVariableBlockDiagonal() line 10482 in E:\cygwin64\home\alireza\PETSc\src\mat\interface\matrix.c >> [0]PETSC ERROR: #3 PCSetUp_VPBJacobi() line 120 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\impls\vpbjacobi\vpbjacobi.c >> [0]PETSC ERROR: #4 PCSetUp() line 932 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\interface\precon.c >> [0]PETSC ERROR: #5 KSPSetUp() line 381 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >> [0]PETSC ERROR: #6 KSPSolve() line 612 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >> [0]PETSC ERROR: #7 SNESSolve_NEWTONLS() line 224 in E:\cygwin64\home\alireza\PETSc\src\snes\impls\ls\ls.c >> [0]PETSC ERROR: #8 SNESSolve() line 4355 in E:\cygwin64\home\alireza\PETSc\src\snes\interface\snes.c >> >> Many thanks, >> Ali >> >> On 8/29/2018 2:24 AM, Smith, Barry F. wrote: >>> Ali, >>> >>> In the branch barry/feature-PCVPBJACOBI (see src/snes/examples/tutorials/ex5.c) I have implemented PCVPBJACOBI that is a point block Jacobi with variable size blocks. It has very little testing. >>> >>> Could you please try your code with it; you should see very very similar convergence history with this branch and the previous approach you used (the only numerical difference between the two approaches is that this one uses a dense LU factorization for each small block while the previous used a sparse factorization). This new one should also be slightly faster in the KSPSolve(). >>> >>> Thanks >>> >>> Barry >>> >>> >>> >>> >>>> On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: >>>> >>>> "Smith, Barry F." writes: >>>> >>>>> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c >>>> Note that this example is block Jacobi with O(1) sparse blocks per >>>> process, not variable-sized point-block Jacobi which I think is what Ali >>>> had in mind. >>>> >>>>> Please let us know if it works for you and if you have any questions or problems. >>>>> >>>>> Barry >>>>> >>>>> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >>>>> >>>>> Sorry for the runaround with so many emails. >>>>> >>>>> >>>>>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>>>>> >>>>>> Hi, >>>>>> >>>>>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>>>>> >>>>>> Below is a part of my code. It is run serially. Any help is much appreciated. >>>>>> >>>>>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>>>>> CHKERRQ(ierr); >>>>>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>>>>> CHKERRQ(ierr); >>>>>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>>>>> CHKERRQ(ierr); >>>>>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>>>>> CHKERRQ(ierr); >>>>>> ierr = SNESSetType(snes, SNESNEWTONLS); >>>>>> CHKERRQ(ierr); >>>>>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>>>>> CHKERRQ(ierr); >>>>>> >>>>>> SNESSetUp(snes); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>>>>> CHKERRQ(ierr); >>>>>> >>>>>> for (i = 0; i < nLocal; i++) { >>>>>> ierr = KSPGetPC(subKSP[i], &SubPc); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCSetType(SubPc, PCLU); >>>>>> CHKERRQ(ierr); >>>>>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>>>>> CHKERRQ(ierr); >>>>>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>>>>> CHKERRQ(ierr); >>>>>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>>>>> CHKERRQ(ierr); >>>>>> } >>>>>> ierr = SNESSolve(snes, NULL, Petsc_X); >>>>>> CHKERRQ(ierr); >>>>>> >>>>>> >>>>>> From balay at mcs.anl.gov Wed Aug 29 12:55:57 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Wed, 29 Aug 2018 12:55:57 -0500 Subject: [petsc-users] C++ Makefile for PETSc program In-Reply-To: References: Message-ID: Easiest thing to do is have the sourcefiles, objfiles and the executable in the same dir - and use PETSc example makefile format. For more involved makefile [with objfiles, makefile, sourcefiles in different locations] - one can look at PETSC_DIR/gmakefile - but that is hard to parse. Satish On Wed, 29 Aug 2018, Justin Dong wrote: > Hi all, > > I have a program with C++ that I am trying to integrate with PETSc on MacOS > X. My Makefile looks like this > > #-----[Makefile]------ > > include ${PETSC_DIR}/lib/petsc/conf/variables > > include ${PETSC_DIR}/lib/petsc/conf/rules > > include ${PETSC_DIR}/lib/petsc/conf/test > > > > > > #----[Directories]---- > > oPath = obj > > sPath = src > > iPath = inc $(PETSC_LIB) > > #==================== > > > > > > #---[Compiler and Settings]----- > > compiler = g++-8 > > compilerFlags = -std=c++11 -Wall -lm -llapack -lblas -O3 > > paths = -I./$(iPath) > > #====================== > > > > > > #----[Variable Names]------- > > headers = $(wildcard $(iPath)/*.hpp) > > sources = $(wildcard $(sPath)/*.cpp) > > objects = $(subst $(sPath)/,$(oPath)/,$(sources:.cpp=.o)) > > #========================== > > > > > > #----[Compilation]--------- > > main:$(objects) $(headers) main.cpp > > $(compiler) $(compilerFlags) -o main $(objects) main.cpp $(PETSC_LIB) > > $(paths) > > $(oPath)/%.o:$(sPath)/%.cpp $(subst $(sPath)/, $(iPath)/,$(<:.cpp=.hpp)) > > @mkdir -p $(@D) > > $(compiler) $(compilerFlags) -o $@ -c $(paths) $< > > > > > > #-----[Clean up]------- > > # clean:rm main > > # rm -rf $(oPath)/ > > > When I try to include "petsc.h", I get a "no such file or directory" error. > I have PETSC_DIR and PETSC_ARCH set correctly, but I'm not the most > proficient with Make. Can someone provide some tips on how to get this > working properly? > > Best, > Justin > From jed at jedbrown.org Wed Aug 29 12:59:40 2018 From: jed at jedbrown.org (Jed Brown) Date: Wed, 29 Aug 2018 11:59:40 -0600 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <7b093784-8da8-1b00-9f31-a327d86882ab@cc.iut.ac.ir> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> <7b093784-8da8-1b00-9f31-a327d86882ab@cc.iut.ac.ir> Message-ID: <87in3t5a0j.fsf@jedbrown.org> This is bjacobi/lu, not vpbjacobi. How are you measuring memory usage? See a couple inline comments below. Ali Reza Khaz'ali writes: > I noticed that I forgot to include the log for 10x10x5 system. Here it is: > > > 1 MPI processes > ? type: newtonls > ? maximum iterations=2000, maximum function evaluations=2000 > ? tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 > ? total number of linear solver iterations=1 > ? total number of function evaluations=2 > ? norm schedule ALWAYS > ? SNESLineSearch Object: 1 MPI processes > ??? type: bt > ????? interpolation: cubic > ????? alpha=1.000000e-04 > ??? maxstep=1.000000e+08, minlambda=1.000000e-12 > ??? tolerances: relative=1.000000e-08, absolute=1.000000e-15, > lambda=1.000000e-08 > ??? maximum iterations=40 > ? KSP Object: 1 MPI processes > ??? type: gmres > ????? restart=30, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > ????? happy breakdown tolerance 1e-30 > ??? maximum iterations=5000, initial guess is zero > ??? tolerances:? relative=1e-05, absolute=1e-06, divergence=10000. > ??? left preconditioning > ??? using PRECONDITIONED norm type for convergence test > ? PC Object: 1 MPI processes > ??? type: bjacobi > ????? number of blocks = 1 > ????? Local solve is same for all blocks, in the following KSP and PC > objects: > ????? KSP Object: (sub_) 1 MPI processes > ??????? type: preonly > ??????? maximum iterations=10000, initial guess is zero > ??????? tolerances:? relative=1e-05, absolute=1e-50, divergence=10000. > ??????? left preconditioning > ??????? using NONE norm type for convergence test > ????? PC Object: (sub_) 1 MPI processes > ??????? type: lu > ????????? out-of-place factorization > ????????? tolerance for zero pivot 2.22045e-14 > ????????? matrix ordering: nd > ????????? factor fill ratio given 0., needed 0. > ??????????? Factored matrix follows: > ????????????? Mat Object: 1 MPI processes > ??????????????? type: mkl_pardiso > ??????????????? rows=6000, cols=6000 > ??????????????? package used to perform factorization: mkl_pardiso > ??????????????? total: nonzeros=150000, allocated nonzeros=150000 > ??????????????? total number of mallocs used during MatSetValues calls =0 > ????????????????? MKL_PARDISO run parameters: > ????????????????? MKL_PARDISO phase:???????????? 33 > ????????????????? MKL_PARDISO iparm[1]:???? 1 > ????????????????? MKL_PARDISO iparm[2]:???? 2 > ????????????????? MKL_PARDISO iparm[3]:???? 2 > ????????????????? MKL_PARDISO iparm[4]:???? 0 > ????????????????? MKL_PARDISO iparm[5]:???? 0 > ????????????????? MKL_PARDISO iparm[6]:???? 0 > ????????????????? MKL_PARDISO iparm[7]:???? 0 > ????????????????? MKL_PARDISO iparm[8]:???? 0 > ????????????????? MKL_PARDISO iparm[9]:???? 0 > ????????????????? MKL_PARDISO iparm[10]:???? 13 > ????????????????? MKL_PARDISO iparm[11]:???? 1 > ????????????????? MKL_PARDISO iparm[12]:???? 0 > ????????????????? MKL_PARDISO iparm[13]:???? 1 > ????????????????? MKL_PARDISO iparm[14]:???? 0 > ????????????????? MKL_PARDISO iparm[15]:???? 11228 > ????????????????? MKL_PARDISO iparm[16]:???? 7563 > ????????????????? MKL_PARDISO iparm[17]:???? 37035 > ????????????????? MKL_PARDISO iparm[18]:???? 4204238 > ????????????????? MKL_PARDISO iparm[19]:???? 2659 > ????????????????? MKL_PARDISO iparm[20]:???? 0 > ????????????????? MKL_PARDISO iparm[21]:???? 0 > ????????????????? MKL_PARDISO iparm[22]:???? 0 > ????????????????? MKL_PARDISO iparm[23]:???? 0 > ????????????????? MKL_PARDISO iparm[24]:???? 0 > ????????????????? MKL_PARDISO iparm[25]:???? 0 > ????????????????? MKL_PARDISO iparm[26]:???? 0 > ????????????????? MKL_PARDISO iparm[27]:???? 0 > ????????????????? MKL_PARDISO iparm[28]:???? 0 > ????????????????? MKL_PARDISO iparm[29]:???? 0 > ????????????????? MKL_PARDISO iparm[30]:???? 0 > ????????????????? MKL_PARDISO iparm[31]:???? 0 > ????????????????? MKL_PARDISO iparm[32]:???? 0 > ????????????????? MKL_PARDISO iparm[33]:???? 0 > ????????????????? MKL_PARDISO iparm[34]:???? -1 > ????????????????? MKL_PARDISO iparm[35]:???? 1 > ????????????????? MKL_PARDISO iparm[36]:???? 0 > ????????????????? MKL_PARDISO iparm[37]:???? 0 > ????????????????? MKL_PARDISO iparm[38]:???? 0 > ????????????????? MKL_PARDISO iparm[39]:???? 0 > ????????????????? MKL_PARDISO iparm[40]:???? 0 > ????????????????? MKL_PARDISO iparm[41]:???? 0 > ????????????????? MKL_PARDISO iparm[42]:???? 0 > ????????????????? MKL_PARDISO iparm[43]:???? 0 > ????????????????? MKL_PARDISO iparm[44]:???? 0 > ????????????????? MKL_PARDISO iparm[45]:???? 0 > ????????????????? MKL_PARDISO iparm[46]:???? 0 > ????????????????? MKL_PARDISO iparm[47]:???? 0 > ????????????????? MKL_PARDISO iparm[48]:???? 0 > ????????????????? MKL_PARDISO iparm[49]:???? 0 > ????????????????? MKL_PARDISO iparm[50]:???? 0 > ????????????????? MKL_PARDISO iparm[51]:???? 0 > ????????????????? MKL_PARDISO iparm[52]:???? 0 > ????????????????? MKL_PARDISO iparm[53]:???? 0 > ????????????????? MKL_PARDISO iparm[54]:???? 0 > ????????????????? MKL_PARDISO iparm[55]:???? 0 > ????????????????? MKL_PARDISO iparm[56]:???? 0 > ????????????????? MKL_PARDISO iparm[57]:???? -1 > ????????????????? MKL_PARDISO iparm[58]:???? 0 > ????????????????? MKL_PARDISO iparm[59]:???? 0 > ????????????????? MKL_PARDISO iparm[60]:???? 0 > ????????????????? MKL_PARDISO iparm[61]:???? 11228 > ????????????????? MKL_PARDISO iparm[62]:???? 7868 > ????????????????? MKL_PARDISO iparm[63]:???? 3629 > ????????????????? MKL_PARDISO iparm[64]:???? 0 > ????????????????? MKL_PARDISO maxfct:???? 1 > ????????????????? MKL_PARDISO mnum:???? 1 > ????????????????? MKL_PARDISO mtype:???? 11 > ????????????????? MKL_PARDISO n:???? 6000 > ????????????????? MKL_PARDISO nrhs:???? 1 > ????????????????? MKL_PARDISO msglvl:???? 0 > ??????? linear system matrix = precond matrix: > ??????? Mat Object: 1 MPI processes > ????????? type: seqaij > ????????? rows=6000, cols=6000 > ????????? total: nonzeros=150000, allocated nonzeros=480000 > ????????? total number of mallocs used during MatSetValues calls =0 > ??????????? not using I-node routines > ??? linear system matrix = precond matrix: > ??? Mat Object: 1 MPI processes > ????? type: seqaij > ????? rows=6000, cols=6000 > ????? total: nonzeros=150000, allocated nonzeros=480000 Note that you preallocated more than necessary here. > ????? total number of mallocs used during MatSetValues calls =0 > ??????? not using I-node routines > ************************************************************************************************************************ > ***???????????? WIDEN YOUR WINDOW TO 120 CHARACTERS.? Use 'enscript -r > -fCourier9' to print this document??????????? *** > ************************************************************************************************************************ > > ---------------------------------------------- PETSc Performance > Summary: ---------------------------------------------- > > E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe > on a? named ALIREZA-PC with 1 processor, by AliReza Wed Aug 29 22:12:30 2018 > Using Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5? GIT Date: > 2018-08-28 19:19:26 -0500 > > ???????????????????????? Max?????? Max/Min???? Avg?????? Total > Time (sec):?????????? 3.373e+01???? 1.000?? 3.373e+01 > Objects:????????????? 3.300e+01???? 1.000?? 3.300e+01 > Flop:???????????????? 7.500e+05???? 1.000?? 7.500e+05? 7.500e+05 > Flop/sec:???????????? 2.224e+04???? 1.000?? 2.224e+04? 2.224e+04 > MPI Messages:???????? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 > MPI Message Lengths:? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 > MPI Reductions:?????? 0.000e+00???? 0.000 > > Flop counting convention: 1 flop = 1 real number operation of type > (multiply/divide/add/subtract) > ??????????????????????????? e.g., VecAXPY() for real vectors of length > N --> 2N flop > ??????????????????????????? and VecAXPY() for complex vectors of length > N --> 8N flop > > Summary of Stages:?? ----- Time ------? ----- Flop ------? --- Messages > ---? -- Message Lengths --? -- Reductions -- > ??????????????????????? Avg???? %Total???? Avg???? %Total Count?? > %Total???? Avg???????? %Total??? Count?? %Total > ?0:????? Main Stage: 3.3730e+01 100.0%? 7.5000e+05 100.0% 0.000e+00?? > 0.0%? 0.000e+00??????? 0.0%? 0.000e+00?? 0.0% > > ------------------------------------------------------------------------------------------------------------------------ > See the 'Profiling' chapter of the users' manual for details on > interpreting output. > Phase summary info: > ?? Count: number of times phase was executed > ?? Time and Flop: Max - maximum over all processors > ????????????????? Ratio - ratio of maximum to minimum over all processors > ?? Mess: number of messages sent > ?? AvgLen: average message length (bytes) > ?? Reduct: number of global reductions > ?? Global: entire computation > ?? Stage: stages of a computation. Set stages with PetscLogStagePush() > and PetscLogStagePop(). > ????? %T - percent time in this phase???????? %F - percent flop in this > phase > ????? %M - percent messages in this phase???? %L - percent message > lengths in this phase > ????? %R - percent reductions in this phase > ?? Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time > over all processors) > ------------------------------------------------------------------------------------------------------------------------ > Event??????????????? Count????? Time (sec) > Flop????????????????????????????? --- Global ---? --- Stage ---- Total > ?????????????????? Max Ratio? Max???? Ratio?? Max? Ratio? Mess AvgLen? > Reduct? %T %F %M %L %R? %T %F %M %L %R Mflop/s > ------------------------------------------------------------------------------------------------------------------------ > > --- Event Stage 0: Main Stage > > BuildTwoSidedF???????? 2 1.0 7.9003e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > SNESSolve????????????? 1 1.0 7.3396e+00 1.0 7.50e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00 22100? 0? 0? 0? 22100? 0? 0? 0???? 0 > SNESFunctionEval?????? 2 1.0 3.8894e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > SNESJacobianEval?????? 1 1.0 5.1611e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 15? 0? 0? 0? 0? 15? 0? 0? 0? 0???? 0 Most of the time here is spent in your code computing the Jacobian, not in the solver. > SNESLineSearch???????? 1 1.0 1.7655e-02 1.0 3.60e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0 48? 0? 0? 0?? 0 48? 0? 0? 0??? 20 > VecDot???????????????? 1 1.0 1.1546e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 1039 > VecMDot??????????????? 1 1.0 2.3093e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0?? 520 > VecNorm??????????????? 5 1.0 4.9769e-01 1.0 6.00e+04 1.0 0.0e+00 0.0e+00 > 0.0e+00? 1? 8? 0? 0? 0?? 1? 8? 0? 0? 0???? 0 > VecScale?????????????? 2 1.0 9.3291e-03 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 1 > VecCopy??????????????? 3 1.0 2.3093e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > VecSet???????????????? 4 1.0 1.5395e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > VecAXPY??????????????? 1 1.0 2.5734e-02 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 0 > VecWAXPY?????????????? 1 1.0 1.3257e-05 1.0 6.00e+03 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0?? 453 > VecMAXPY?????????????? 2 1.0 2.3521e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0? 1020 > VecAssemblyBegin?????? 2 1.0 7.9040e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > VecAssemblyEnd???????? 2 1.0 1.7961e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > VecReduceArith???????? 2 1.0 9.8359e-06 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0? 2440 > VecReduceComm????????? 1 1.0 4.7041e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > VecNormalize?????????? 2 1.0 9.3552e-03 1.0 3.60e+04 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0???? 4 > MatMult??????????????? 2 1.0 4.4860e-04 1.0 5.88e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0 78? 0? 0? 0?? 0 78? 0? 0? 0? 1311 > MatSolve?????????????? 2 1.0 1.7876e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 > MatLUFactorSym???????? 1 1.0 7.6157e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 > MatLUFactorNum???????? 1 1.0 6.5977e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 > MatAssemblyBegin?????? 2 1.0 0.0000e+00 0.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > MatAssemblyEnd???????? 2 1.0 1.2962e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > MatGetRowIJ??????????? 1 1.0 1.1534e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > MatGetOrdering???????? 1 1.0 5.1809e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > MatZeroEntries???????? 1 1.0 1.1298e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > MatView??????????????? 3 1.0 3.8344e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 > KSPSetUp?????????????? 2 1.0 3.2843e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > KSPSolve?????????????? 1 1.0 1.6414e+00 1.0 3.78e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00? 5 50? 0? 0? 0?? 5 50? 0? 0? 0???? 0 > KSPGMRESOrthog???????? 1 1.0 5.9015e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0?? 407 > PCSetUp??????????????? 2 1.0 1.4267e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 > PCSetUpOnBlocks??????? 1 1.0 1.4266e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 > PCApply??????????????? 2 1.0 1.7882e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 > ------------------------------------------------------------------------------------------------------------------------ > > Memory usage is given in bytes: > > Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. > Reports information only for process 0. > > --- Event Stage 0: Main Stage > > ??????????????? SNES???? 1????????????? 0??????????? 0???? 0. > ????????????? DMSNES???? 1????????????? 0??????????? 0???? 0. > ????? SNESLineSearch???? 1????????????? 0??????????? 0???? 0. > ????????????? Vector??? 12????????????? 0??????????? 0???? 0. > ????????????? Matrix???? 2????????????? 0??????????? 0???? 0. > ??? Distributed Mesh???? 2????????????? 0??????????? 0???? 0. > ?????????? Index Set???? 2????????????? 0??????????? 0???? 0. > ?? Star Forest Graph???? 4????????????? 0??????????? 0???? 0. > ???? Discrete System???? 2????????????? 0??????????? 0???? 0. > ?????? Krylov Solver???? 2????????????? 0??????????? 0???? 0. > ???? DMKSP interface???? 1????????????? 0??????????? 0???? 0. > ????? Preconditioner???? 2????????????? 0??????????? 0???? 0. > ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. > ======================================================================================================================== > Average time to get PetscTime(): 4.27647e-08 > #PETSc Option Table entries: > -ksp_atol 1e-6 > -ksp_rtol 1e-5 > -snes_rtol 1e-4 > -sub_ksp_type preonly > -sub_pc_factor_mat_solver_type mkl_pardiso > -sub_pc_type lu > #End of PETSc Option Table entries > Compiled without FORTRAN kernels > Compiled with full precision matrices (default) > sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 > sizeof(PetscScalar) 8 sizeof(PetscInt) 4 > Configure options: --prefix=/home/alireza/PetscGit > --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl > --with-hypre-incl > ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include > --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib > --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in > clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib > ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" > --with-mpi-include=/cygdrive/E/Program_Fi > les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include > --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int > el64/lib/impi.lib > --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe > --with-debugging=0 --with-blas > -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool > s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" > -FFLAGS="-MT -O2 -Qopenmp" > ----------------------------------------- > Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC > Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit > Using PETSc directory: /home/alireza/PetscGit > Using PETSc arch: > ----------------------------------------- > > Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl > -O2 -MT -wd4996 -Qopenmp > Using Fortran compiler: > /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp > -fpp > ----------------------------------------- > > Using include paths: -I/home/alireza/PetscGit/include > -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include > -I/cygdrive/E/hypre-2.11.2/ > Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include > -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include > ----------------------------------------- > > Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl > Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe > ifort > Using libraries: -L/home/alireza/PetscGit/lib > -L/home/alireza/PetscGit/lib -lpetsc > /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib > /cygdrive/E/Trilinos-master/Bins/lib > /ml.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and > _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib > Gdi32.lib User32.lib > ?Advapi32.lib Kernel32.lib Ws2_32.lib > ----------------------------------------- > > > > On 8/29/2018 7:40 PM, Smith, Barry F. wrote: >> You need to add the line >> >> ierr = MatSetVariableBlockSizes(J,3,lens);CHKERRQ(ierr); >> >> with the number of blocks replacing 3 and the sizes of each block in lens >> >> Barry >> >> >>> On Aug 29, 2018, at 4:27 AM, Ali Reza Khaz'ali wrote: >>> >>> Barry, >>> >>> Thanks a lot for your efforts. Using PCVPBJACOBI causes SNESSolve to throw the following error (the code and the system being simulated is the same, just PCBJACOBI changed to PCVPBJACOBI): >>> >>> >>> [0]PETSC ERROR: --------------------- Error Message --------------------------------------- >>> ----------------------- >>> [0]PETSC ERROR: Nonconforming object sizes >>> [0]PETSC ERROR: Total blocksizes 0 doesn't match number matrix rows 108000 >>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5 GIT Date: 2018-08-28 19:19:26 -0500 >>> [0]PETSC ERROR: E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a named ALIREZA-PC by AliReza Wed Aug 29 13:46:38 2018 >>> [0]PETSC ERROR: Configure options --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl -- >>> with-hypre-include=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos >>> -master/Bins/include --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdri >>> ve/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/ >>> windows/mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debuggin >>> g=0 --with-blas-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_ >>> x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 - >>> Qopenmp" >>> [0]PETSC ERROR: #1 MatInvertVariableBlockDiagonal_SeqAIJ() line 1569 in E:\cygwin64\home\alireza\PETSc\src\mat\impls\aij\seq\aij.c >>> [0]PETSC ERROR: #2 MatInvertVariableBlockDiagonal() line 10482 in E:\cygwin64\home\alireza\PETSc\src\mat\interface\matrix.c >>> [0]PETSC ERROR: #3 PCSetUp_VPBJacobi() line 120 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\impls\vpbjacobi\vpbjacobi.c >>> [0]PETSC ERROR: #4 PCSetUp() line 932 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\interface\precon.c >>> [0]PETSC ERROR: #5 KSPSetUp() line 381 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >>> [0]PETSC ERROR: #6 KSPSolve() line 612 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >>> [0]PETSC ERROR: #7 SNESSolve_NEWTONLS() line 224 in E:\cygwin64\home\alireza\PETSc\src\snes\impls\ls\ls.c >>> [0]PETSC ERROR: #8 SNESSolve() line 4355 in E:\cygwin64\home\alireza\PETSc\src\snes\interface\snes.c >>> >>> Many thanks, >>> Ali >>> >>> On 8/29/2018 2:24 AM, Smith, Barry F. wrote: >>>> Ali, >>>> >>>> In the branch barry/feature-PCVPBJACOBI (see src/snes/examples/tutorials/ex5.c) I have implemented PCVPBJACOBI that is a point block Jacobi with variable size blocks. It has very little testing. >>>> >>>> Could you please try your code with it; you should see very very similar convergence history with this branch and the previous approach you used (the only numerical difference between the two approaches is that this one uses a dense LU factorization for each small block while the previous used a sparse factorization). This new one should also be slightly faster in the KSPSolve(). >>>> >>>> Thanks >>>> >>>> Barry >>>> >>>> >>>> >>>> >>>>> On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: >>>>> >>>>> "Smith, Barry F." writes: >>>>> >>>>>> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c >>>>> Note that this example is block Jacobi with O(1) sparse blocks per >>>>> process, not variable-sized point-block Jacobi which I think is what Ali >>>>> had in mind. >>>>> >>>>>> Please let us know if it works for you and if you have any questions or problems. >>>>>> >>>>>> Barry >>>>>> >>>>>> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >>>>>> >>>>>> Sorry for the runaround with so many emails. >>>>>> >>>>>> >>>>>>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>>>>>> >>>>>>> Hi, >>>>>>> >>>>>>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>>>>>> >>>>>>> Below is a part of my code. It is run serially. Any help is much appreciated. >>>>>>> >>>>>>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = SNESSetType(snes, SNESNEWTONLS); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>>>>>> CHKERRQ(ierr); >>>>>>> >>>>>>> SNESSetUp(snes); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>>>>>> CHKERRQ(ierr); >>>>>>> >>>>>>> for (i = 0; i < nLocal; i++) { >>>>>>> ierr = KSPGetPC(subKSP[i], &SubPc); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = PCSetType(SubPc, PCLU); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>>>>>> CHKERRQ(ierr); >>>>>>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>>>>>> CHKERRQ(ierr); >>>>>>> } >>>>>>> ierr = SNESSolve(snes, NULL, Petsc_X); >>>>>>> CHKERRQ(ierr); >>>>>>> >>>>>>> >>>>>>> From arkhazali at cc.iut.ac.ir Wed Aug 29 13:18:04 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Wed, 29 Aug 2018 22:48:04 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <87in3t5a0j.fsf@jedbrown.org> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> <7b093784-8da8-1b00-9f31-a327d86882ab@cc.iut.ac.ir> <87in3t5a0j.fsf@jedbrown.org> Message-ID: <82f16e58-ab8e-2ab8-eb6b-26b9bd8e820e@cc.iut.ac.ir> Oh I'm sorry. There have been a lot of changes in my code, and I lost track of them. I've fixed the code, and the log for 30x30x10 system is as follows. I measure the memory usage with windows task manager. Both of your comment are true. This is just a test run, and I'll optimize it ASAP. Thanks again. Best wishes, Ali 1 MPI processes ? type: newtonls ? maximum iterations=2000, maximum function evaluations=2000 ? tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 ? total number of linear solver iterations=3 ? total number of function evaluations=2 ? norm schedule ALWAYS ? SNESLineSearch Object: 1 MPI processes ??? type: bt ????? interpolation: cubic ????? alpha=1.000000e-04 ??? maxstep=1.000000e+08, minlambda=1.000000e-12 ??? tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 ??? maximum iterations=40 ? KSP Object: 1 MPI processes ??? type: gmres ????? restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement ????? happy breakdown tolerance 1e-30 ??? maximum iterations=5000, initial guess is zero ??? tolerances:? relative=1e-05, absolute=1e-06, divergence=10000. ??? left preconditioning ??? using PRECONDITIONED norm type for convergence test ? PC Object: 1 MPI processes ??? type: vpbjacobi ??? linear system matrix = precond matrix: ??? Mat Object: 1 MPI processes ????? type: seqaij ????? rows=108000, cols=108000 ????? total: nonzeros=2868000, allocated nonzeros=8640000 ????? total number of mallocs used during MatSetValues calls =0 ??????? not using I-node routines ************************************************************************************************************************ ***???????????? WIDEN YOUR WINDOW TO 120 CHARACTERS.? Use 'enscript -r -fCourier9' to print this document??????????? *** ************************************************************************************************************************ ---------------------------------------------- PETSc Performance Summary: ---------------------------------------------- E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a? named ALIREZA-PC with 1 processor, by AliReza Wed Aug 29 22:43:35 2018 Using Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5? GIT Date: 2018-08-28 19:19:26 -0500 ???????????????????????? Max?????? Max/Min???? Avg?????? Total Time (sec):?????????? 1.187e+02???? 1.000?? 1.187e+02 Objects:????????????? 3.600e+01???? 1.000?? 3.600e+01 Flop:???????????????? 2.867e+07???? 1.000?? 2.867e+07? 2.867e+07 Flop/sec:???????????? 2.414e+05???? 1.000?? 2.414e+05? 2.414e+05 MPI Messages:???????? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 MPI Message Lengths:? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 MPI Reductions:?????? 0.000e+00???? 0.000 Flop counting convention: 1 flop = 1 real number operation of type (multiply/divide/add/subtract) ??????????????????????????? e.g., VecAXPY() for real vectors of length N --> 2N flop ??????????????????????????? and VecAXPY() for complex vectors of length N --> 8N flop Summary of Stages:?? ----- Time ------? ----- Flop ------? --- Messages ---? -- Message Lengths --? -- Reductions -- ??????????????????????? Avg???? %Total???? Avg???? %Total Count?? %Total???? Avg???????? %Total??? Count?? %Total ?0:????? Main Stage: 1.1875e+02 100.0%? 2.8668e+07 100.0% 0.000e+00?? 0.0%? 0.000e+00??????? 0.0%? 0.000e+00?? 0.0% ------------------------------------------------------------------------------------------------------------------------ See the 'Profiling' chapter of the users' manual for details on interpreting output. Phase summary info: ?? Count: number of times phase was executed ?? Time and Flop: Max - maximum over all processors ????????????????? Ratio - ratio of maximum to minimum over all processors ?? Mess: number of messages sent ?? AvgLen: average message length (bytes) ?? Reduct: number of global reductions ?? Global: entire computation ?? Stage: stages of a computation. Set stages with PetscLogStagePush() and PetscLogStagePop(). ????? %T - percent time in this phase???????? %F - percent flop in this phase ????? %M - percent messages in this phase???? %L - percent message lengths in this phase ????? %R - percent reductions in this phase ?? Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time over all processors) ------------------------------------------------------------------------------------------------------------------------ Event??????????????? Count????? Time (sec) Flop????????????????????????????? --- Global ---? --- Stage ---- Total ?????????????????? Max Ratio? Max???? Ratio?? Max? Ratio? Mess AvgLen? Reduct? %T %F %M %L %R? %T %F %M %L %R Mflop/s ------------------------------------------------------------------------------------------------------------------------ --- Event Stage 0: Main Stage BuildTwoSidedF???????? 2 1.0 2.7369e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 SNESSolve????????????? 1 1.0 9.8642e+01 1.0 2.87e+07 1.0 0.0e+00 0.0e+00 0.0e+00 83100? 0? 0? 0? 83100? 0? 0? 0???? 0 SNESFunctionEval?????? 2 1.0 5.4137e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 5? 0? 0? 0? 0?? 5? 0? 0? 0? 0???? 0 SNESJacobianEval?????? 1 1.0 9.3167e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 78? 0? 0? 0? 0? 78? 0? 0? 0? 0???? 0 SNESLineSearch???????? 1 1.0 2.6980e+00 1.0 6.82e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 2 24? 0? 0? 0?? 2 24? 0? 0? 0???? 3 VecDot???????????????? 1 1.0 1.7705e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0? 1220 VecMDot??????????????? 3 1.0 7.4411e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0? 1742 VecNorm??????????????? 7 1.0 5.9443e-03 1.0 1.51e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0?? 254 VecScale?????????????? 4 1.0 1.4882e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 2903 VecCopy??????????????? 3 1.0 4.6827e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecSet???????????????? 2 1.0 1.3899e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecAXPY??????????????? 1 1.0 1.5652e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0? 1380 VecWAXPY?????????????? 1 1.0 1.7448e-04 1.0 1.08e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0?? 619 VecMAXPY?????????????? 4 1.0 7.7233e-04 1.0 1.94e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 7? 0? 0? 0?? 0? 7? 0? 0? 0? 2517 VecAssemblyBegin?????? 2 1.0 4.6614e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecAssemblyEnd???????? 2 1.0 7.2700e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecReduceArith???????? 2 1.0 2.3948e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 1804 VecReduceComm????????? 1 1.0 2.1382e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecNormalize?????????? 4 1.0 4.1995e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0? 3086 MatMult??????????????? 4 1.0 1.6703e-02 1.0 2.25e+07 1.0 0.0e+00 0.0e+00 0.0e+00? 0 79? 0? 0? 0?? 0 79? 0? 0? 0? 1348 MatAssemblyBegin?????? 2 1.0 1.2829e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatAssemblyEnd???????? 2 1.0 2.6648e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatZeroEntries???????? 1 1.0 5.4123e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatView??????????????? 1 1.0 6.0384e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 KSPSetUp?????????????? 1 1.0 4.3723e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 KSPSolve?????????????? 1 1.0 4.9647e-02 1.0 2.16e+07 1.0 0.0e+00 0.0e+00 0.0e+00? 0 75? 0? 0? 0?? 0 75? 0? 0? 0?? 436 KSPGMRESOrthog???????? 3 1.0 1.2919e-03 1.0 2.59e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 9? 0? 0? 0?? 0? 9? 0? 0? 0? 2006 PCSetUp??????????????? 1 1.0 1.8846e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 PCApply??????????????? 4 1.0 2.9807e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 ------------------------------------------------------------------------------------------------------------------------ Memory usage is given in bytes: Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. Reports information only for process 0. --- Event Stage 0: Main Stage ??????????????? SNES???? 1????????????? 0??????????? 0???? 0. ????????????? DMSNES???? 1????????????? 0??????????? 0???? 0. ????? SNESLineSearch???? 1????????????? 0??????????? 0???? 0. ????????????? Vector??? 20????????????? 0??????????? 0???? 0. ????????????? Matrix???? 1????????????? 0??????????? 0???? 0. ??? Distributed Mesh???? 2????????????? 0??????????? 0???? 0. ?? Star Forest Graph???? 4????????????? 0??????????? 0???? 0. ???? Discrete System???? 2????????????? 0??????????? 0???? 0. ?????? Krylov Solver???? 1????????????? 0??????????? 0???? 0. ???? DMKSP interface???? 1????????????? 0??????????? 0???? 0. ????? Preconditioner???? 1????????????? 0??????????? 0???? 0. ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. ======================================================================================================================== Average time to get PetscTime(): 8.55292e-08 #PETSc Option Table entries: -ksp_atol 1e-6 -ksp_rtol 1e-5 -snes_rtol 1e-4 -sub_ksp_type preonly -sub_pc_factor_mat_solver_type mkl_pardiso -sub_pc_type lu #End of PETSc Option Table entries Compiled without FORTRAN kernels Compiled with full precision matrices (default) sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 sizeof(PetscScalar) 8 sizeof(PetscInt) 4 Configure options: --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl --with-hypre-incl ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdrive/E/Program_Fi les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int el64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debugging=0 --with-blas -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 -Qopenmp" ----------------------------------------- Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit Using PETSc directory: /home/alireza/PetscGit Using PETSc arch: ----------------------------------------- Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl -O2 -MT -wd4996 -Qopenmp Using Fortran compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp -fpp ----------------------------------------- Using include paths: -I/home/alireza/PetscGit/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include -I/cygdrive/E/hypre-2.11.2/ Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include ----------------------------------------- Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort Using libraries: -L/home/alireza/PetscGit/lib -L/home/alireza/PetscGit/lib -lpetsc /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib /cygdrive/E/Trilinos-master/Bins/lib /ml.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Gdi32.lib User32.lib ?Advapi32.lib Kernel32.lib Ws2_32.lib ----------------------------------------- On 8/29/2018 10:29 PM, Jed Brown wrote: > This is bjacobi/lu, not vpbjacobi. > > How are you measuring memory usage? See a couple inline comments below. > > Ali Reza Khaz'ali writes: > >> I noticed that I forgot to include the log for 10x10x5 system. Here it is: >> >> >> 1 MPI processes >> ? type: newtonls >> ? maximum iterations=2000, maximum function evaluations=2000 >> ? tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 >> ? total number of linear solver iterations=1 >> ? total number of function evaluations=2 >> ? norm schedule ALWAYS >> ? SNESLineSearch Object: 1 MPI processes >> ??? type: bt >> ????? interpolation: cubic >> ????? alpha=1.000000e-04 >> ??? maxstep=1.000000e+08, minlambda=1.000000e-12 >> ??? tolerances: relative=1.000000e-08, absolute=1.000000e-15, >> lambda=1.000000e-08 >> ??? maximum iterations=40 >> ? KSP Object: 1 MPI processes >> ??? type: gmres >> ????? restart=30, using Classical (unmodified) Gram-Schmidt >> Orthogonalization with no iterative refinement >> ????? happy breakdown tolerance 1e-30 >> ??? maximum iterations=5000, initial guess is zero >> ??? tolerances:? relative=1e-05, absolute=1e-06, divergence=10000. >> ??? left preconditioning >> ??? using PRECONDITIONED norm type for convergence test >> ? PC Object: 1 MPI processes >> ??? type: bjacobi >> ????? number of blocks = 1 >> ????? Local solve is same for all blocks, in the following KSP and PC >> objects: >> ????? KSP Object: (sub_) 1 MPI processes >> ??????? type: preonly >> ??????? maximum iterations=10000, initial guess is zero >> ??????? tolerances:? relative=1e-05, absolute=1e-50, divergence=10000. >> ??????? left preconditioning >> ??????? using NONE norm type for convergence test >> ????? PC Object: (sub_) 1 MPI processes >> ??????? type: lu >> ????????? out-of-place factorization >> ????????? tolerance for zero pivot 2.22045e-14 >> ????????? matrix ordering: nd >> ????????? factor fill ratio given 0., needed 0. >> ??????????? Factored matrix follows: >> ????????????? Mat Object: 1 MPI processes >> ??????????????? type: mkl_pardiso >> ??????????????? rows=6000, cols=6000 >> ??????????????? package used to perform factorization: mkl_pardiso >> ??????????????? total: nonzeros=150000, allocated nonzeros=150000 >> ??????????????? total number of mallocs used during MatSetValues calls =0 >> ????????????????? MKL_PARDISO run parameters: >> ????????????????? MKL_PARDISO phase:???????????? 33 >> ????????????????? MKL_PARDISO iparm[1]:???? 1 >> ????????????????? MKL_PARDISO iparm[2]:???? 2 >> ????????????????? MKL_PARDISO iparm[3]:???? 2 >> ????????????????? MKL_PARDISO iparm[4]:???? 0 >> ????????????????? MKL_PARDISO iparm[5]:???? 0 >> ????????????????? MKL_PARDISO iparm[6]:???? 0 >> ????????????????? MKL_PARDISO iparm[7]:???? 0 >> ????????????????? MKL_PARDISO iparm[8]:???? 0 >> ????????????????? MKL_PARDISO iparm[9]:???? 0 >> ????????????????? MKL_PARDISO iparm[10]:???? 13 >> ????????????????? MKL_PARDISO iparm[11]:???? 1 >> ????????????????? MKL_PARDISO iparm[12]:???? 0 >> ????????????????? MKL_PARDISO iparm[13]:???? 1 >> ????????????????? MKL_PARDISO iparm[14]:???? 0 >> ????????????????? MKL_PARDISO iparm[15]:???? 11228 >> ????????????????? MKL_PARDISO iparm[16]:???? 7563 >> ????????????????? MKL_PARDISO iparm[17]:???? 37035 >> ????????????????? MKL_PARDISO iparm[18]:???? 4204238 >> ????????????????? MKL_PARDISO iparm[19]:???? 2659 >> ????????????????? MKL_PARDISO iparm[20]:???? 0 >> ????????????????? MKL_PARDISO iparm[21]:???? 0 >> ????????????????? MKL_PARDISO iparm[22]:???? 0 >> ????????????????? MKL_PARDISO iparm[23]:???? 0 >> ????????????????? MKL_PARDISO iparm[24]:???? 0 >> ????????????????? MKL_PARDISO iparm[25]:???? 0 >> ????????????????? MKL_PARDISO iparm[26]:???? 0 >> ????????????????? MKL_PARDISO iparm[27]:???? 0 >> ????????????????? MKL_PARDISO iparm[28]:???? 0 >> ????????????????? MKL_PARDISO iparm[29]:???? 0 >> ????????????????? MKL_PARDISO iparm[30]:???? 0 >> ????????????????? MKL_PARDISO iparm[31]:???? 0 >> ????????????????? MKL_PARDISO iparm[32]:???? 0 >> ????????????????? MKL_PARDISO iparm[33]:???? 0 >> ????????????????? MKL_PARDISO iparm[34]:???? -1 >> ????????????????? MKL_PARDISO iparm[35]:???? 1 >> ????????????????? MKL_PARDISO iparm[36]:???? 0 >> ????????????????? MKL_PARDISO iparm[37]:???? 0 >> ????????????????? MKL_PARDISO iparm[38]:???? 0 >> ????????????????? MKL_PARDISO iparm[39]:???? 0 >> ????????????????? MKL_PARDISO iparm[40]:???? 0 >> ????????????????? MKL_PARDISO iparm[41]:???? 0 >> ????????????????? MKL_PARDISO iparm[42]:???? 0 >> ????????????????? MKL_PARDISO iparm[43]:???? 0 >> ????????????????? MKL_PARDISO iparm[44]:???? 0 >> ????????????????? MKL_PARDISO iparm[45]:???? 0 >> ????????????????? MKL_PARDISO iparm[46]:???? 0 >> ????????????????? MKL_PARDISO iparm[47]:???? 0 >> ????????????????? MKL_PARDISO iparm[48]:???? 0 >> ????????????????? MKL_PARDISO iparm[49]:???? 0 >> ????????????????? MKL_PARDISO iparm[50]:???? 0 >> ????????????????? MKL_PARDISO iparm[51]:???? 0 >> ????????????????? MKL_PARDISO iparm[52]:???? 0 >> ????????????????? MKL_PARDISO iparm[53]:???? 0 >> ????????????????? MKL_PARDISO iparm[54]:???? 0 >> ????????????????? MKL_PARDISO iparm[55]:???? 0 >> ????????????????? MKL_PARDISO iparm[56]:???? 0 >> ????????????????? MKL_PARDISO iparm[57]:???? -1 >> ????????????????? MKL_PARDISO iparm[58]:???? 0 >> ????????????????? MKL_PARDISO iparm[59]:???? 0 >> ????????????????? MKL_PARDISO iparm[60]:???? 0 >> ????????????????? MKL_PARDISO iparm[61]:???? 11228 >> ????????????????? MKL_PARDISO iparm[62]:???? 7868 >> ????????????????? MKL_PARDISO iparm[63]:???? 3629 >> ????????????????? MKL_PARDISO iparm[64]:???? 0 >> ????????????????? MKL_PARDISO maxfct:???? 1 >> ????????????????? MKL_PARDISO mnum:???? 1 >> ????????????????? MKL_PARDISO mtype:???? 11 >> ????????????????? MKL_PARDISO n:???? 6000 >> ????????????????? MKL_PARDISO nrhs:???? 1 >> ????????????????? MKL_PARDISO msglvl:???? 0 >> ??????? linear system matrix = precond matrix: >> ??????? Mat Object: 1 MPI processes >> ????????? type: seqaij >> ????????? rows=6000, cols=6000 >> ????????? total: nonzeros=150000, allocated nonzeros=480000 >> ????????? total number of mallocs used during MatSetValues calls =0 >> ??????????? not using I-node routines >> ??? linear system matrix = precond matrix: >> ??? Mat Object: 1 MPI processes >> ????? type: seqaij >> ????? rows=6000, cols=6000 >> ????? total: nonzeros=150000, allocated nonzeros=480000 > Note that you preallocated more than necessary here. > >> ????? total number of mallocs used during MatSetValues calls =0 >> ??????? not using I-node routines >> ************************************************************************************************************************ >> ***???????????? WIDEN YOUR WINDOW TO 120 CHARACTERS.? Use 'enscript -r >> -fCourier9' to print this document??????????? *** >> ************************************************************************************************************************ >> >> ---------------------------------------------- PETSc Performance >> Summary: ---------------------------------------------- >> >> E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe >> on a? named ALIREZA-PC with 1 processor, by AliReza Wed Aug 29 22:12:30 2018 >> Using Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5? GIT Date: >> 2018-08-28 19:19:26 -0500 >> >> ???????????????????????? Max?????? Max/Min???? Avg?????? Total >> Time (sec):?????????? 3.373e+01???? 1.000?? 3.373e+01 >> Objects:????????????? 3.300e+01???? 1.000?? 3.300e+01 >> Flop:???????????????? 7.500e+05???? 1.000?? 7.500e+05? 7.500e+05 >> Flop/sec:???????????? 2.224e+04???? 1.000?? 2.224e+04? 2.224e+04 >> MPI Messages:???????? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 >> MPI Message Lengths:? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 >> MPI Reductions:?????? 0.000e+00???? 0.000 >> >> Flop counting convention: 1 flop = 1 real number operation of type >> (multiply/divide/add/subtract) >> ??????????????????????????? e.g., VecAXPY() for real vectors of length >> N --> 2N flop >> ??????????????????????????? and VecAXPY() for complex vectors of length >> N --> 8N flop >> >> Summary of Stages:?? ----- Time ------? ----- Flop ------? --- Messages >> ---? -- Message Lengths --? -- Reductions -- >> ??????????????????????? Avg???? %Total???? Avg???? %Total Count >> %Total???? Avg???????? %Total??? Count?? %Total >> ?0:????? Main Stage: 3.3730e+01 100.0%? 7.5000e+05 100.0% 0.000e+00 >> 0.0%? 0.000e+00??????? 0.0%? 0.000e+00?? 0.0% >> >> ------------------------------------------------------------------------------------------------------------------------ >> See the 'Profiling' chapter of the users' manual for details on >> interpreting output. >> Phase summary info: >> ?? Count: number of times phase was executed >> ?? Time and Flop: Max - maximum over all processors >> ????????????????? Ratio - ratio of maximum to minimum over all processors >> ?? Mess: number of messages sent >> ?? AvgLen: average message length (bytes) >> ?? Reduct: number of global reductions >> ?? Global: entire computation >> ?? Stage: stages of a computation. Set stages with PetscLogStagePush() >> and PetscLogStagePop(). >> ????? %T - percent time in this phase???????? %F - percent flop in this >> phase >> ????? %M - percent messages in this phase???? %L - percent message >> lengths in this phase >> ????? %R - percent reductions in this phase >> ?? Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time >> over all processors) >> ------------------------------------------------------------------------------------------------------------------------ >> Event??????????????? Count????? Time (sec) >> Flop????????????????????????????? --- Global ---? --- Stage ---- Total >> ?????????????????? Max Ratio? Max???? Ratio?? Max? Ratio? Mess AvgLen >> Reduct? %T %F %M %L %R? %T %F %M %L %R Mflop/s >> ------------------------------------------------------------------------------------------------------------------------ >> >> --- Event Stage 0: Main Stage >> >> BuildTwoSidedF???????? 2 1.0 7.9003e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> SNESSolve????????????? 1 1.0 7.3396e+00 1.0 7.50e+05 1.0 0.0e+00 0.0e+00 >> 0.0e+00 22100? 0? 0? 0? 22100? 0? 0? 0???? 0 >> SNESFunctionEval?????? 2 1.0 3.8894e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> SNESJacobianEval?????? 1 1.0 5.1611e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00 15? 0? 0? 0? 0? 15? 0? 0? 0? 0???? 0 > Most of the time here is spent in your code computing the Jacobian, not > in the solver. > >> SNESLineSearch???????? 1 1.0 1.7655e-02 1.0 3.60e+05 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0 48? 0? 0? 0?? 0 48? 0? 0? 0??? 20 >> VecDot???????????????? 1 1.0 1.1546e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 1039 >> VecMDot??????????????? 1 1.0 2.3093e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0?? 520 >> VecNorm??????????????? 5 1.0 4.9769e-01 1.0 6.00e+04 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 1? 8? 0? 0? 0?? 1? 8? 0? 0? 0???? 0 >> VecScale?????????????? 2 1.0 9.3291e-03 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 1 >> VecCopy??????????????? 3 1.0 2.3093e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> VecSet???????????????? 4 1.0 1.5395e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> VecAXPY??????????????? 1 1.0 2.5734e-02 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 0 >> VecWAXPY?????????????? 1 1.0 1.3257e-05 1.0 6.00e+03 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0?? 453 >> VecMAXPY?????????????? 2 1.0 2.3521e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0? 1020 >> VecAssemblyBegin?????? 2 1.0 7.9040e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> VecAssemblyEnd???????? 2 1.0 1.7961e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> VecReduceArith???????? 2 1.0 9.8359e-06 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0? 2440 >> VecReduceComm????????? 1 1.0 4.7041e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> VecNormalize?????????? 2 1.0 9.3552e-03 1.0 3.60e+04 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0???? 4 >> MatMult??????????????? 2 1.0 4.4860e-04 1.0 5.88e+05 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0 78? 0? 0? 0?? 0 78? 0? 0? 0? 1311 >> MatSolve?????????????? 2 1.0 1.7876e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 >> MatLUFactorSym???????? 1 1.0 7.6157e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 >> MatLUFactorNum???????? 1 1.0 6.5977e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 >> MatAssemblyBegin?????? 2 1.0 0.0000e+00 0.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> MatAssemblyEnd???????? 2 1.0 1.2962e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> MatGetRowIJ??????????? 1 1.0 1.1534e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> MatGetOrdering???????? 1 1.0 5.1809e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> MatZeroEntries???????? 1 1.0 1.1298e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> MatView??????????????? 3 1.0 3.8344e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 >> KSPSetUp?????????????? 2 1.0 3.2843e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >> KSPSolve?????????????? 1 1.0 1.6414e+00 1.0 3.78e+05 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 5 50? 0? 0? 0?? 5 50? 0? 0? 0???? 0 >> KSPGMRESOrthog???????? 1 1.0 5.9015e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >> 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0?? 407 >> PCSetUp??????????????? 2 1.0 1.4267e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 >> PCSetUpOnBlocks??????? 1 1.0 1.4266e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 >> PCApply??????????????? 2 1.0 1.7882e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >> 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 >> ------------------------------------------------------------------------------------------------------------------------ >> >> Memory usage is given in bytes: >> >> Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. >> Reports information only for process 0. >> >> --- Event Stage 0: Main Stage >> >> ??????????????? SNES???? 1????????????? 0??????????? 0???? 0. >> ????????????? DMSNES???? 1????????????? 0??????????? 0???? 0. >> ????? SNESLineSearch???? 1????????????? 0??????????? 0???? 0. >> ????????????? Vector??? 12????????????? 0??????????? 0???? 0. >> ????????????? Matrix???? 2????????????? 0??????????? 0???? 0. >> ??? Distributed Mesh???? 2????????????? 0??????????? 0???? 0. >> ?????????? Index Set???? 2????????????? 0??????????? 0???? 0. >> ?? Star Forest Graph???? 4????????????? 0??????????? 0???? 0. >> ???? Discrete System???? 2????????????? 0??????????? 0???? 0. >> ?????? Krylov Solver???? 2????????????? 0??????????? 0???? 0. >> ???? DMKSP interface???? 1????????????? 0??????????? 0???? 0. >> ????? Preconditioner???? 2????????????? 0??????????? 0???? 0. >> ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. >> ======================================================================================================================== >> Average time to get PetscTime(): 4.27647e-08 >> #PETSc Option Table entries: >> -ksp_atol 1e-6 >> -ksp_rtol 1e-5 >> -snes_rtol 1e-4 >> -sub_ksp_type preonly >> -sub_pc_factor_mat_solver_type mkl_pardiso >> -sub_pc_type lu >> #End of PETSc Option Table entries >> Compiled without FORTRAN kernels >> Compiled with full precision matrices (default) >> sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 >> sizeof(PetscScalar) 8 sizeof(PetscInt) 4 >> Configure options: --prefix=/home/alireza/PetscGit >> --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl >> --with-hypre-incl >> ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include >> --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >> --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in >> clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib >> ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" >> --with-mpi-include=/cygdrive/E/Program_Fi >> les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >> --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int >> el64/lib/impi.lib >> --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe >> --with-debugging=0 --with-blas >> -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool >> s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" >> -FFLAGS="-MT -O2 -Qopenmp" >> ----------------------------------------- >> Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC >> Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit >> Using PETSc directory: /home/alireza/PetscGit >> Using PETSc arch: >> ----------------------------------------- >> >> Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >> -O2 -MT -wd4996 -Qopenmp >> Using Fortran compiler: >> /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp >> -fpp >> ----------------------------------------- >> >> Using include paths: -I/home/alireza/PetscGit/include >> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include >> -I/cygdrive/E/hypre-2.11.2/ >> Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include >> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >> ----------------------------------------- >> >> Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >> Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe >> ifort >> Using libraries: -L/home/alireza/PetscGit/lib >> -L/home/alireza/PetscGit/lib -lpetsc >> /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >> /cygdrive/E/Trilinos-master/Bins/lib >> /ml.lib >> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and >> _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib >> Gdi32.lib User32.lib >> ?Advapi32.lib Kernel32.lib Ws2_32.lib >> ----------------------------------------- >> >> >> >> On 8/29/2018 7:40 PM, Smith, Barry F. wrote: >>> You need to add the line >>> >>> ierr = MatSetVariableBlockSizes(J,3,lens);CHKERRQ(ierr); >>> >>> with the number of blocks replacing 3 and the sizes of each block in lens >>> >>> Barry >>> >>> >>>> On Aug 29, 2018, at 4:27 AM, Ali Reza Khaz'ali wrote: >>>> >>>> Barry, >>>> >>>> Thanks a lot for your efforts. Using PCVPBJACOBI causes SNESSolve to throw the following error (the code and the system being simulated is the same, just PCBJACOBI changed to PCVPBJACOBI): >>>> >>>> >>>> [0]PETSC ERROR: --------------------- Error Message --------------------------------------- >>>> ----------------------- >>>> [0]PETSC ERROR: Nonconforming object sizes >>>> [0]PETSC ERROR: Total blocksizes 0 doesn't match number matrix rows 108000 >>>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >>>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5 GIT Date: 2018-08-28 19:19:26 -0500 >>>> [0]PETSC ERROR: E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a named ALIREZA-PC by AliReza Wed Aug 29 13:46:38 2018 >>>> [0]PETSC ERROR: Configure options --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl -- >>>> with-hypre-include=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos >>>> -master/Bins/include --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdri >>>> ve/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/ >>>> windows/mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debuggin >>>> g=0 --with-blas-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_ >>>> x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 - >>>> Qopenmp" >>>> [0]PETSC ERROR: #1 MatInvertVariableBlockDiagonal_SeqAIJ() line 1569 in E:\cygwin64\home\alireza\PETSc\src\mat\impls\aij\seq\aij.c >>>> [0]PETSC ERROR: #2 MatInvertVariableBlockDiagonal() line 10482 in E:\cygwin64\home\alireza\PETSc\src\mat\interface\matrix.c >>>> [0]PETSC ERROR: #3 PCSetUp_VPBJacobi() line 120 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\impls\vpbjacobi\vpbjacobi.c >>>> [0]PETSC ERROR: #4 PCSetUp() line 932 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\interface\precon.c >>>> [0]PETSC ERROR: #5 KSPSetUp() line 381 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >>>> [0]PETSC ERROR: #6 KSPSolve() line 612 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >>>> [0]PETSC ERROR: #7 SNESSolve_NEWTONLS() line 224 in E:\cygwin64\home\alireza\PETSc\src\snes\impls\ls\ls.c >>>> [0]PETSC ERROR: #8 SNESSolve() line 4355 in E:\cygwin64\home\alireza\PETSc\src\snes\interface\snes.c >>>> >>>> Many thanks, >>>> Ali >>>> >>>> On 8/29/2018 2:24 AM, Smith, Barry F. wrote: >>>>> Ali, >>>>> >>>>> In the branch barry/feature-PCVPBJACOBI (see src/snes/examples/tutorials/ex5.c) I have implemented PCVPBJACOBI that is a point block Jacobi with variable size blocks. It has very little testing. >>>>> >>>>> Could you please try your code with it; you should see very very similar convergence history with this branch and the previous approach you used (the only numerical difference between the two approaches is that this one uses a dense LU factorization for each small block while the previous used a sparse factorization). This new one should also be slightly faster in the KSPSolve(). >>>>> >>>>> Thanks >>>>> >>>>> Barry >>>>> >>>>> >>>>> >>>>> >>>>>> On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: >>>>>> >>>>>> "Smith, Barry F." writes: >>>>>> >>>>>>> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c >>>>>> Note that this example is block Jacobi with O(1) sparse blocks per >>>>>> process, not variable-sized point-block Jacobi which I think is what Ali >>>>>> had in mind. >>>>>> >>>>>>> Please let us know if it works for you and if you have any questions or problems. >>>>>>> >>>>>>> Barry >>>>>>> >>>>>>> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >>>>>>> >>>>>>> Sorry for the runaround with so many emails. >>>>>>> >>>>>>> >>>>>>>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>>>>>>> >>>>>>>> Hi, >>>>>>>> >>>>>>>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>>>>>>> >>>>>>>> Below is a part of my code. It is run serially. Any help is much appreciated. >>>>>>>> >>>>>>>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = SNESSetType(snes, SNESNEWTONLS); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>>>>>>> CHKERRQ(ierr); >>>>>>>> >>>>>>>> SNESSetUp(snes); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>>>>>>> CHKERRQ(ierr); >>>>>>>> >>>>>>>> for (i = 0; i < nLocal; i++) { >>>>>>>> ierr = KSPGetPC(subKSP[i], &SubPc); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = PCSetType(SubPc, PCLU); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>>>>>>> CHKERRQ(ierr); >>>>>>>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>>>>>>> CHKERRQ(ierr); >>>>>>>> } >>>>>>>> ierr = SNESSolve(snes, NULL, Petsc_X); >>>>>>>> CHKERRQ(ierr); >>>>>>>> >>>>>>>> >>>>>>>> -- Ali Reza Khaz?ali Assistant Professor of Petroleum Engineering, Department of Chemical Engineering Isfahan University of Technology Isfahan, Iran From jed at jedbrown.org Wed Aug 29 13:35:45 2018 From: jed at jedbrown.org (Jed Brown) Date: Wed, 29 Aug 2018 12:35:45 -0600 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <82f16e58-ab8e-2ab8-eb6b-26b9bd8e820e@cc.iut.ac.ir> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> <7b093784-8da8-1b00-9f31-a327d86882ab@cc.iut.ac.ir> <87in3t5a0j.fsf@jedbrown.org> <82f16e58-ab8e-2ab8-eb6b-26b9bd8e820e@cc.iut.ac.ir> Message-ID: <87a7p558ce.fsf@jedbrown.org> Ali Reza Khaz'ali writes: > Oh I'm sorry. There have been a lot of changes in my code, and I lost > track of them. I've fixed the code, and the log for 30x30x10 system is > as follows. I measure the memory usage with windows task manager. Both > of your comment are true. This is just a test run, and I'll optimize it > ASAP. You might want to use a memory profiler to see if you have important leaks. See comment below about destroying objects and PETSc memory logging. > > 1 MPI processes > ? type: newtonls > ? maximum iterations=2000, maximum function evaluations=2000 > ? tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 > ? total number of linear solver iterations=3 > ? total number of function evaluations=2 > ? norm schedule ALWAYS > ? SNESLineSearch Object: 1 MPI processes > ??? type: bt > ????? interpolation: cubic > ????? alpha=1.000000e-04 > ??? maxstep=1.000000e+08, minlambda=1.000000e-12 > ??? tolerances: relative=1.000000e-08, absolute=1.000000e-15, > lambda=1.000000e-08 > ??? maximum iterations=40 > ? KSP Object: 1 MPI processes > ??? type: gmres > ????? restart=30, using Classical (unmodified) Gram-Schmidt > Orthogonalization with no iterative refinement > ????? happy breakdown tolerance 1e-30 > ??? maximum iterations=5000, initial guess is zero > ??? tolerances:? relative=1e-05, absolute=1e-06, divergence=10000. > ??? left preconditioning > ??? using PRECONDITIONED norm type for convergence test > ? PC Object: 1 MPI processes > ??? type: vpbjacobi > ??? linear system matrix = precond matrix: > ??? Mat Object: 1 MPI processes > ????? type: seqaij > ????? rows=108000, cols=108000 > ????? total: nonzeros=2868000, allocated nonzeros=8640000 This matrix takes just a little over 100 MB (only about 35 MB of which is needed). If this code is using a lot more memory than that, you should use a memory profiler to find out where (e.g., some data structures in your code). > ????? total number of mallocs used during MatSetValues calls =0 > ??????? not using I-node routines > ************************************************************************************************************************ > ***???????????? WIDEN YOUR WINDOW TO 120 CHARACTERS.? Use 'enscript -r > -fCourier9' to print this document??????????? *** > ************************************************************************************************************************ > > ---------------------------------------------- PETSc Performance > Summary: ---------------------------------------------- > > E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe > on a? named ALIREZA-PC with 1 processor, by AliReza Wed Aug 29 22:43:35 2018 > Using Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5? GIT Date: > 2018-08-28 19:19:26 -0500 > > ???????????????????????? Max?????? Max/Min???? Avg?????? Total > Time (sec):?????????? 1.187e+02???? 1.000?? 1.187e+02 > Objects:????????????? 3.600e+01???? 1.000?? 3.600e+01 > Flop:???????????????? 2.867e+07???? 1.000?? 2.867e+07? 2.867e+07 > Flop/sec:???????????? 2.414e+05???? 1.000?? 2.414e+05? 2.414e+05 > MPI Messages:???????? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 > MPI Message Lengths:? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 > MPI Reductions:?????? 0.000e+00???? 0.000 > > Flop counting convention: 1 flop = 1 real number operation of type > (multiply/divide/add/subtract) > ??????????????????????????? e.g., VecAXPY() for real vectors of length > N --> 2N flop > ??????????????????????????? and VecAXPY() for complex vectors of length > N --> 8N flop > > Summary of Stages:?? ----- Time ------? ----- Flop ------? --- Messages > ---? -- Message Lengths --? -- Reductions -- > ??????????????????????? Avg???? %Total???? Avg???? %Total Count?? > %Total???? Avg???????? %Total??? Count?? %Total > ?0:????? Main Stage: 1.1875e+02 100.0%? 2.8668e+07 100.0% 0.000e+00?? > 0.0%? 0.000e+00??????? 0.0%? 0.000e+00?? 0.0% > > ------------------------------------------------------------------------------------------------------------------------ > See the 'Profiling' chapter of the users' manual for details on > interpreting output. > Phase summary info: > ?? Count: number of times phase was executed > ?? Time and Flop: Max - maximum over all processors > ????????????????? Ratio - ratio of maximum to minimum over all processors > ?? Mess: number of messages sent > ?? AvgLen: average message length (bytes) > ?? Reduct: number of global reductions > ?? Global: entire computation > ?? Stage: stages of a computation. Set stages with PetscLogStagePush() > and PetscLogStagePop(). > ????? %T - percent time in this phase???????? %F - percent flop in this > phase > ????? %M - percent messages in this phase???? %L - percent message > lengths in this phase > ????? %R - percent reductions in this phase > ?? Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time > over all processors) > ------------------------------------------------------------------------------------------------------------------------ > Event??????????????? Count????? Time (sec) > Flop????????????????????????????? --- Global ---? --- Stage ---- Total > ?????????????????? Max Ratio? Max???? Ratio?? Max? Ratio? Mess AvgLen? > Reduct? %T %F %M %L %R? %T %F %M %L %R Mflop/s > ------------------------------------------------------------------------------------------------------------------------ > > --- Event Stage 0: Main Stage > > BuildTwoSidedF???????? 2 1.0 2.7369e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > SNESSolve????????????? 1 1.0 9.8642e+01 1.0 2.87e+07 1.0 0.0e+00 0.0e+00 > 0.0e+00 83100? 0? 0? 0? 83100? 0? 0? 0???? 0 > SNESFunctionEval?????? 2 1.0 5.4137e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 5? 0? 0? 0? 0?? 5? 0? 0? 0? 0???? 0 > SNESJacobianEval?????? 1 1.0 9.3167e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00 78? 0? 0? 0? 0? 78? 0? 0? 0? 0???? 0 All of your time is in function and Jacobian evaluation. > SNESLineSearch???????? 1 1.0 2.6980e+00 1.0 6.82e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00? 2 24? 0? 0? 0?? 2 24? 0? 0? 0???? 3 > VecDot???????????????? 1 1.0 1.7705e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0? 1220 > VecMDot??????????????? 3 1.0 7.4411e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0? 1742 > VecNorm??????????????? 7 1.0 5.9443e-03 1.0 1.51e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0?? 254 > VecScale?????????????? 4 1.0 1.4882e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 2903 > VecCopy??????????????? 3 1.0 4.6827e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > VecSet???????????????? 2 1.0 1.3899e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > VecAXPY??????????????? 1 1.0 1.5652e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0? 1380 > VecWAXPY?????????????? 1 1.0 1.7448e-04 1.0 1.08e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0?? 619 > VecMAXPY?????????????? 4 1.0 7.7233e-04 1.0 1.94e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 7? 0? 0? 0?? 0? 7? 0? 0? 0? 2517 > VecAssemblyBegin?????? 2 1.0 4.6614e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > VecAssemblyEnd???????? 2 1.0 7.2700e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > VecReduceArith???????? 2 1.0 2.3948e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 1804 > VecReduceComm????????? 1 1.0 2.1382e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > VecNormalize?????????? 4 1.0 4.1995e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0? 3086 > MatMult??????????????? 4 1.0 1.6703e-02 1.0 2.25e+07 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0 79? 0? 0? 0?? 0 79? 0? 0? 0? 1348 > MatAssemblyBegin?????? 2 1.0 1.2829e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > MatAssemblyEnd???????? 2 1.0 2.6648e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > MatZeroEntries???????? 1 1.0 5.4123e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > MatView??????????????? 1 1.0 6.0384e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > KSPSetUp?????????????? 1 1.0 4.3723e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > KSPSolve?????????????? 1 1.0 4.9647e-02 1.0 2.16e+07 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0 75? 0? 0? 0?? 0 75? 0? 0? 0?? 436 The entire linear solve is less than 50 milliseconds. > KSPGMRESOrthog???????? 3 1.0 1.2919e-03 1.0 2.59e+06 1.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 9? 0? 0? 0?? 0? 9? 0? 0? 0? 2006 > PCSetUp??????????????? 1 1.0 1.8846e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > PCApply??????????????? 4 1.0 2.9807e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 > 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 > ------------------------------------------------------------------------------------------------------------------------ > > Memory usage is given in bytes: > > Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. > Reports information only for process 0. > > --- Event Stage 0: Main Stage > > ??????????????? SNES???? 1????????????? 0??????????? 0???? 0. > ????????????? DMSNES???? 1????????????? 0??????????? 0???? 0. > ????? SNESLineSearch???? 1????????????? 0??????????? 0???? 0. > ????????????? Vector??? 20????????????? 0??????????? 0???? 0. > ????????????? Matrix???? 1????????????? 0??????????? 0???? 0. > ??? Distributed Mesh???? 2????????????? 0??????????? 0???? 0. > ?? Star Forest Graph???? 4????????????? 0??????????? 0???? 0. > ???? Discrete System???? 2????????????? 0??????????? 0???? 0. > ?????? Krylov Solver???? 1????????????? 0??????????? 0???? 0. > ???? DMKSP interface???? 1????????????? 0??????????? 0???? 0. > ????? Preconditioner???? 1????????????? 0??????????? 0???? 0. > ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. It looks like you have forgotten to destroy all of your objects. If you clean up after yourself, you'll also see the totaly memory used by each of the PETSc classes that you use. > ======================================================================================================================== > Average time to get PetscTime(): 8.55292e-08 > #PETSc Option Table entries: > -ksp_atol 1e-6 > -ksp_rtol 1e-5 > -snes_rtol 1e-4 > -sub_ksp_type preonly > -sub_pc_factor_mat_solver_type mkl_pardiso > -sub_pc_type lu > #End of PETSc Option Table entries > Compiled without FORTRAN kernels > Compiled with full precision matrices (default) > sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 > sizeof(PetscScalar) 8 sizeof(PetscInt) 4 > Configure options: --prefix=/home/alireza/PetscGit > --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl > --with-hypre-incl > ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include > --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib > --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in > clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib > ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" > --with-mpi-include=/cygdrive/E/Program_Fi > les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include > --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int > el64/lib/impi.lib > --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe > --with-debugging=0 --with-blas > -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool > s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" > -FFLAGS="-MT -O2 -Qopenmp" > ----------------------------------------- > Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC > Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit > Using PETSc directory: /home/alireza/PetscGit > Using PETSc arch: > ----------------------------------------- > > Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl > -O2 -MT -wd4996 -Qopenmp > Using Fortran compiler: > /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp > -fpp > ----------------------------------------- > > Using include paths: -I/home/alireza/PetscGit/include > -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include > -I/cygdrive/E/hypre-2.11.2/ > Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include > -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include > ----------------------------------------- > > Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl > Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe > ifort > Using libraries: -L/home/alireza/PetscGit/lib > -L/home/alireza/PetscGit/lib -lpetsc > /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib > /cygdrive/E/Trilinos-master/Bins/lib > /ml.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and > _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib > /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib > Gdi32.lib User32.lib > ?Advapi32.lib Kernel32.lib Ws2_32.lib > ----------------------------------------- > > > > > > On 8/29/2018 10:29 PM, Jed Brown wrote: >> This is bjacobi/lu, not vpbjacobi. >> >> How are you measuring memory usage? See a couple inline comments below. >> >> Ali Reza Khaz'ali writes: >> >>> I noticed that I forgot to include the log for 10x10x5 system. Here it is: >>> >>> >>> 1 MPI processes >>> ? type: newtonls >>> ? maximum iterations=2000, maximum function evaluations=2000 >>> ? tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 >>> ? total number of linear solver iterations=1 >>> ? total number of function evaluations=2 >>> ? norm schedule ALWAYS >>> ? SNESLineSearch Object: 1 MPI processes >>> ??? type: bt >>> ????? interpolation: cubic >>> ????? alpha=1.000000e-04 >>> ??? maxstep=1.000000e+08, minlambda=1.000000e-12 >>> ??? tolerances: relative=1.000000e-08, absolute=1.000000e-15, >>> lambda=1.000000e-08 >>> ??? maximum iterations=40 >>> ? KSP Object: 1 MPI processes >>> ??? type: gmres >>> ????? restart=30, using Classical (unmodified) Gram-Schmidt >>> Orthogonalization with no iterative refinement >>> ????? happy breakdown tolerance 1e-30 >>> ??? maximum iterations=5000, initial guess is zero >>> ??? tolerances:? relative=1e-05, absolute=1e-06, divergence=10000. >>> ??? left preconditioning >>> ??? using PRECONDITIONED norm type for convergence test >>> ? PC Object: 1 MPI processes >>> ??? type: bjacobi >>> ????? number of blocks = 1 >>> ????? Local solve is same for all blocks, in the following KSP and PC >>> objects: >>> ????? KSP Object: (sub_) 1 MPI processes >>> ??????? type: preonly >>> ??????? maximum iterations=10000, initial guess is zero >>> ??????? tolerances:? relative=1e-05, absolute=1e-50, divergence=10000. >>> ??????? left preconditioning >>> ??????? using NONE norm type for convergence test >>> ????? PC Object: (sub_) 1 MPI processes >>> ??????? type: lu >>> ????????? out-of-place factorization >>> ????????? tolerance for zero pivot 2.22045e-14 >>> ????????? matrix ordering: nd >>> ????????? factor fill ratio given 0., needed 0. >>> ??????????? Factored matrix follows: >>> ????????????? Mat Object: 1 MPI processes >>> ??????????????? type: mkl_pardiso >>> ??????????????? rows=6000, cols=6000 >>> ??????????????? package used to perform factorization: mkl_pardiso >>> ??????????????? total: nonzeros=150000, allocated nonzeros=150000 >>> ??????????????? total number of mallocs used during MatSetValues calls =0 >>> ????????????????? MKL_PARDISO run parameters: >>> ????????????????? MKL_PARDISO phase:???????????? 33 >>> ????????????????? MKL_PARDISO iparm[1]:???? 1 >>> ????????????????? MKL_PARDISO iparm[2]:???? 2 >>> ????????????????? MKL_PARDISO iparm[3]:???? 2 >>> ????????????????? MKL_PARDISO iparm[4]:???? 0 >>> ????????????????? MKL_PARDISO iparm[5]:???? 0 >>> ????????????????? MKL_PARDISO iparm[6]:???? 0 >>> ????????????????? MKL_PARDISO iparm[7]:???? 0 >>> ????????????????? MKL_PARDISO iparm[8]:???? 0 >>> ????????????????? MKL_PARDISO iparm[9]:???? 0 >>> ????????????????? MKL_PARDISO iparm[10]:???? 13 >>> ????????????????? MKL_PARDISO iparm[11]:???? 1 >>> ????????????????? MKL_PARDISO iparm[12]:???? 0 >>> ????????????????? MKL_PARDISO iparm[13]:???? 1 >>> ????????????????? MKL_PARDISO iparm[14]:???? 0 >>> ????????????????? MKL_PARDISO iparm[15]:???? 11228 >>> ????????????????? MKL_PARDISO iparm[16]:???? 7563 >>> ????????????????? MKL_PARDISO iparm[17]:???? 37035 >>> ????????????????? MKL_PARDISO iparm[18]:???? 4204238 >>> ????????????????? MKL_PARDISO iparm[19]:???? 2659 >>> ????????????????? MKL_PARDISO iparm[20]:???? 0 >>> ????????????????? MKL_PARDISO iparm[21]:???? 0 >>> ????????????????? MKL_PARDISO iparm[22]:???? 0 >>> ????????????????? MKL_PARDISO iparm[23]:???? 0 >>> ????????????????? MKL_PARDISO iparm[24]:???? 0 >>> ????????????????? MKL_PARDISO iparm[25]:???? 0 >>> ????????????????? MKL_PARDISO iparm[26]:???? 0 >>> ????????????????? MKL_PARDISO iparm[27]:???? 0 >>> ????????????????? MKL_PARDISO iparm[28]:???? 0 >>> ????????????????? MKL_PARDISO iparm[29]:???? 0 >>> ????????????????? MKL_PARDISO iparm[30]:???? 0 >>> ????????????????? MKL_PARDISO iparm[31]:???? 0 >>> ????????????????? MKL_PARDISO iparm[32]:???? 0 >>> ????????????????? MKL_PARDISO iparm[33]:???? 0 >>> ????????????????? MKL_PARDISO iparm[34]:???? -1 >>> ????????????????? MKL_PARDISO iparm[35]:???? 1 >>> ????????????????? MKL_PARDISO iparm[36]:???? 0 >>> ????????????????? MKL_PARDISO iparm[37]:???? 0 >>> ????????????????? MKL_PARDISO iparm[38]:???? 0 >>> ????????????????? MKL_PARDISO iparm[39]:???? 0 >>> ????????????????? MKL_PARDISO iparm[40]:???? 0 >>> ????????????????? MKL_PARDISO iparm[41]:???? 0 >>> ????????????????? MKL_PARDISO iparm[42]:???? 0 >>> ????????????????? MKL_PARDISO iparm[43]:???? 0 >>> ????????????????? MKL_PARDISO iparm[44]:???? 0 >>> ????????????????? MKL_PARDISO iparm[45]:???? 0 >>> ????????????????? MKL_PARDISO iparm[46]:???? 0 >>> ????????????????? MKL_PARDISO iparm[47]:???? 0 >>> ????????????????? MKL_PARDISO iparm[48]:???? 0 >>> ????????????????? MKL_PARDISO iparm[49]:???? 0 >>> ????????????????? MKL_PARDISO iparm[50]:???? 0 >>> ????????????????? MKL_PARDISO iparm[51]:???? 0 >>> ????????????????? MKL_PARDISO iparm[52]:???? 0 >>> ????????????????? MKL_PARDISO iparm[53]:???? 0 >>> ????????????????? MKL_PARDISO iparm[54]:???? 0 >>> ????????????????? MKL_PARDISO iparm[55]:???? 0 >>> ????????????????? MKL_PARDISO iparm[56]:???? 0 >>> ????????????????? MKL_PARDISO iparm[57]:???? -1 >>> ????????????????? MKL_PARDISO iparm[58]:???? 0 >>> ????????????????? MKL_PARDISO iparm[59]:???? 0 >>> ????????????????? MKL_PARDISO iparm[60]:???? 0 >>> ????????????????? MKL_PARDISO iparm[61]:???? 11228 >>> ????????????????? MKL_PARDISO iparm[62]:???? 7868 >>> ????????????????? MKL_PARDISO iparm[63]:???? 3629 >>> ????????????????? MKL_PARDISO iparm[64]:???? 0 >>> ????????????????? MKL_PARDISO maxfct:???? 1 >>> ????????????????? MKL_PARDISO mnum:???? 1 >>> ????????????????? MKL_PARDISO mtype:???? 11 >>> ????????????????? MKL_PARDISO n:???? 6000 >>> ????????????????? MKL_PARDISO nrhs:???? 1 >>> ????????????????? MKL_PARDISO msglvl:???? 0 >>> ??????? linear system matrix = precond matrix: >>> ??????? Mat Object: 1 MPI processes >>> ????????? type: seqaij >>> ????????? rows=6000, cols=6000 >>> ????????? total: nonzeros=150000, allocated nonzeros=480000 >>> ????????? total number of mallocs used during MatSetValues calls =0 >>> ??????????? not using I-node routines >>> ??? linear system matrix = precond matrix: >>> ??? Mat Object: 1 MPI processes >>> ????? type: seqaij >>> ????? rows=6000, cols=6000 >>> ????? total: nonzeros=150000, allocated nonzeros=480000 >> Note that you preallocated more than necessary here. >> >>> ????? total number of mallocs used during MatSetValues calls =0 >>> ??????? not using I-node routines >>> ************************************************************************************************************************ >>> ***???????????? WIDEN YOUR WINDOW TO 120 CHARACTERS.? Use 'enscript -r >>> -fCourier9' to print this document??????????? *** >>> ************************************************************************************************************************ >>> >>> ---------------------------------------------- PETSc Performance >>> Summary: ---------------------------------------------- >>> >>> E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe >>> on a? named ALIREZA-PC with 1 processor, by AliReza Wed Aug 29 22:12:30 2018 >>> Using Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5? GIT Date: >>> 2018-08-28 19:19:26 -0500 >>> >>> ???????????????????????? Max?????? Max/Min???? Avg?????? Total >>> Time (sec):?????????? 3.373e+01???? 1.000?? 3.373e+01 >>> Objects:????????????? 3.300e+01???? 1.000?? 3.300e+01 >>> Flop:???????????????? 7.500e+05???? 1.000?? 7.500e+05? 7.500e+05 >>> Flop/sec:???????????? 2.224e+04???? 1.000?? 2.224e+04? 2.224e+04 >>> MPI Messages:???????? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 >>> MPI Message Lengths:? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 >>> MPI Reductions:?????? 0.000e+00???? 0.000 >>> >>> Flop counting convention: 1 flop = 1 real number operation of type >>> (multiply/divide/add/subtract) >>> ??????????????????????????? e.g., VecAXPY() for real vectors of length >>> N --> 2N flop >>> ??????????????????????????? and VecAXPY() for complex vectors of length >>> N --> 8N flop >>> >>> Summary of Stages:?? ----- Time ------? ----- Flop ------? --- Messages >>> ---? -- Message Lengths --? -- Reductions -- >>> ??????????????????????? Avg???? %Total???? Avg???? %Total Count >>> %Total???? Avg???????? %Total??? Count?? %Total >>> ?0:????? Main Stage: 3.3730e+01 100.0%? 7.5000e+05 100.0% 0.000e+00 >>> 0.0%? 0.000e+00??????? 0.0%? 0.000e+00?? 0.0% >>> >>> ------------------------------------------------------------------------------------------------------------------------ >>> See the 'Profiling' chapter of the users' manual for details on >>> interpreting output. >>> Phase summary info: >>> ?? Count: number of times phase was executed >>> ?? Time and Flop: Max - maximum over all processors >>> ????????????????? Ratio - ratio of maximum to minimum over all processors >>> ?? Mess: number of messages sent >>> ?? AvgLen: average message length (bytes) >>> ?? Reduct: number of global reductions >>> ?? Global: entire computation >>> ?? Stage: stages of a computation. Set stages with PetscLogStagePush() >>> and PetscLogStagePop(). >>> ????? %T - percent time in this phase???????? %F - percent flop in this >>> phase >>> ????? %M - percent messages in this phase???? %L - percent message >>> lengths in this phase >>> ????? %R - percent reductions in this phase >>> ?? Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time >>> over all processors) >>> ------------------------------------------------------------------------------------------------------------------------ >>> Event??????????????? Count????? Time (sec) >>> Flop????????????????????????????? --- Global ---? --- Stage ---- Total >>> ?????????????????? Max Ratio? Max???? Ratio?? Max? Ratio? Mess AvgLen >>> Reduct? %T %F %M %L %R? %T %F %M %L %R Mflop/s >>> ------------------------------------------------------------------------------------------------------------------------ >>> >>> --- Event Stage 0: Main Stage >>> >>> BuildTwoSidedF???????? 2 1.0 7.9003e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> SNESSolve????????????? 1 1.0 7.3396e+00 1.0 7.50e+05 1.0 0.0e+00 0.0e+00 >>> 0.0e+00 22100? 0? 0? 0? 22100? 0? 0? 0???? 0 >>> SNESFunctionEval?????? 2 1.0 3.8894e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> SNESJacobianEval?????? 1 1.0 5.1611e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00 15? 0? 0? 0? 0? 15? 0? 0? 0? 0???? 0 >> Most of the time here is spent in your code computing the Jacobian, not >> in the solver. >> >>> SNESLineSearch???????? 1 1.0 1.7655e-02 1.0 3.60e+05 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0 48? 0? 0? 0?? 0 48? 0? 0? 0??? 20 >>> VecDot???????????????? 1 1.0 1.1546e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 1039 >>> VecMDot??????????????? 1 1.0 2.3093e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0?? 520 >>> VecNorm??????????????? 5 1.0 4.9769e-01 1.0 6.00e+04 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 1? 8? 0? 0? 0?? 1? 8? 0? 0? 0???? 0 >>> VecScale?????????????? 2 1.0 9.3291e-03 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 1 >>> VecCopy??????????????? 3 1.0 2.3093e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> VecSet???????????????? 4 1.0 1.5395e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> VecAXPY??????????????? 1 1.0 2.5734e-02 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 0 >>> VecWAXPY?????????????? 1 1.0 1.3257e-05 1.0 6.00e+03 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0?? 453 >>> VecMAXPY?????????????? 2 1.0 2.3521e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0? 1020 >>> VecAssemblyBegin?????? 2 1.0 7.9040e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> VecAssemblyEnd???????? 2 1.0 1.7961e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> VecReduceArith???????? 2 1.0 9.8359e-06 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0? 2440 >>> VecReduceComm????????? 1 1.0 4.7041e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> VecNormalize?????????? 2 1.0 9.3552e-03 1.0 3.60e+04 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0???? 4 >>> MatMult??????????????? 2 1.0 4.4860e-04 1.0 5.88e+05 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0 78? 0? 0? 0?? 0 78? 0? 0? 0? 1311 >>> MatSolve?????????????? 2 1.0 1.7876e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 >>> MatLUFactorSym???????? 1 1.0 7.6157e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 >>> MatLUFactorNum???????? 1 1.0 6.5977e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 >>> MatAssemblyBegin?????? 2 1.0 0.0000e+00 0.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> MatAssemblyEnd???????? 2 1.0 1.2962e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> MatGetRowIJ??????????? 1 1.0 1.1534e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> MatGetOrdering???????? 1 1.0 5.1809e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> MatZeroEntries???????? 1 1.0 1.1298e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> MatView??????????????? 3 1.0 3.8344e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 >>> KSPSetUp?????????????? 2 1.0 3.2843e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>> KSPSolve?????????????? 1 1.0 1.6414e+00 1.0 3.78e+05 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 5 50? 0? 0? 0?? 5 50? 0? 0? 0???? 0 >>> KSPGMRESOrthog???????? 1 1.0 5.9015e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >>> 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0?? 407 >>> PCSetUp??????????????? 2 1.0 1.4267e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 >>> PCSetUpOnBlocks??????? 1 1.0 1.4266e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 >>> PCApply??????????????? 2 1.0 1.7882e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>> 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 >>> ------------------------------------------------------------------------------------------------------------------------ >>> >>> Memory usage is given in bytes: >>> >>> Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. >>> Reports information only for process 0. >>> >>> --- Event Stage 0: Main Stage >>> >>> ??????????????? SNES???? 1????????????? 0??????????? 0???? 0. >>> ????????????? DMSNES???? 1????????????? 0??????????? 0???? 0. >>> ????? SNESLineSearch???? 1????????????? 0??????????? 0???? 0. >>> ????????????? Vector??? 12????????????? 0??????????? 0???? 0. >>> ????????????? Matrix???? 2????????????? 0??????????? 0???? 0. >>> ??? Distributed Mesh???? 2????????????? 0??????????? 0???? 0. >>> ?????????? Index Set???? 2????????????? 0??????????? 0???? 0. >>> ?? Star Forest Graph???? 4????????????? 0??????????? 0???? 0. >>> ???? Discrete System???? 2????????????? 0??????????? 0???? 0. >>> ?????? Krylov Solver???? 2????????????? 0??????????? 0???? 0. >>> ???? DMKSP interface???? 1????????????? 0??????????? 0???? 0. >>> ????? Preconditioner???? 2????????????? 0??????????? 0???? 0. >>> ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. >>> ======================================================================================================================== >>> Average time to get PetscTime(): 4.27647e-08 >>> #PETSc Option Table entries: >>> -ksp_atol 1e-6 >>> -ksp_rtol 1e-5 >>> -snes_rtol 1e-4 >>> -sub_ksp_type preonly >>> -sub_pc_factor_mat_solver_type mkl_pardiso >>> -sub_pc_type lu >>> #End of PETSc Option Table entries >>> Compiled without FORTRAN kernels >>> Compiled with full precision matrices (default) >>> sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 >>> sizeof(PetscScalar) 8 sizeof(PetscInt) 4 >>> Configure options: --prefix=/home/alireza/PetscGit >>> --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl >>> --with-hypre-incl >>> ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include >>> --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >>> --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in >>> clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib >>> ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" >>> --with-mpi-include=/cygdrive/E/Program_Fi >>> les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >>> --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int >>> el64/lib/impi.lib >>> --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe >>> --with-debugging=0 --with-blas >>> -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool >>> s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" >>> -FFLAGS="-MT -O2 -Qopenmp" >>> ----------------------------------------- >>> Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC >>> Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit >>> Using PETSc directory: /home/alireza/PetscGit >>> Using PETSc arch: >>> ----------------------------------------- >>> >>> Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >>> -O2 -MT -wd4996 -Qopenmp >>> Using Fortran compiler: >>> /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp >>> -fpp >>> ----------------------------------------- >>> >>> Using include paths: -I/home/alireza/PetscGit/include >>> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include >>> -I/cygdrive/E/hypre-2.11.2/ >>> Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include >>> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >>> ----------------------------------------- >>> >>> Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >>> Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe >>> ifort >>> Using libraries: -L/home/alireza/PetscGit/lib >>> -L/home/alireza/PetscGit/lib -lpetsc >>> /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >>> /cygdrive/E/Trilinos-master/Bins/lib >>> /ml.lib >>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and >>> _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib >>> Gdi32.lib User32.lib >>> ?Advapi32.lib Kernel32.lib Ws2_32.lib >>> ----------------------------------------- >>> >>> >>> >>> On 8/29/2018 7:40 PM, Smith, Barry F. wrote: >>>> You need to add the line >>>> >>>> ierr = MatSetVariableBlockSizes(J,3,lens);CHKERRQ(ierr); >>>> >>>> with the number of blocks replacing 3 and the sizes of each block in lens >>>> >>>> Barry >>>> >>>> >>>>> On Aug 29, 2018, at 4:27 AM, Ali Reza Khaz'ali wrote: >>>>> >>>>> Barry, >>>>> >>>>> Thanks a lot for your efforts. Using PCVPBJACOBI causes SNESSolve to throw the following error (the code and the system being simulated is the same, just PCBJACOBI changed to PCVPBJACOBI): >>>>> >>>>> >>>>> [0]PETSC ERROR: --------------------- Error Message --------------------------------------- >>>>> ----------------------- >>>>> [0]PETSC ERROR: Nonconforming object sizes >>>>> [0]PETSC ERROR: Total blocksizes 0 doesn't match number matrix rows 108000 >>>>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >>>>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5 GIT Date: 2018-08-28 19:19:26 -0500 >>>>> [0]PETSC ERROR: E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a named ALIREZA-PC by AliReza Wed Aug 29 13:46:38 2018 >>>>> [0]PETSC ERROR: Configure options --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl -- >>>>> with-hypre-include=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos >>>>> -master/Bins/include --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdri >>>>> ve/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/ >>>>> windows/mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debuggin >>>>> g=0 --with-blas-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_ >>>>> x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 - >>>>> Qopenmp" >>>>> [0]PETSC ERROR: #1 MatInvertVariableBlockDiagonal_SeqAIJ() line 1569 in E:\cygwin64\home\alireza\PETSc\src\mat\impls\aij\seq\aij.c >>>>> [0]PETSC ERROR: #2 MatInvertVariableBlockDiagonal() line 10482 in E:\cygwin64\home\alireza\PETSc\src\mat\interface\matrix.c >>>>> [0]PETSC ERROR: #3 PCSetUp_VPBJacobi() line 120 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\impls\vpbjacobi\vpbjacobi.c >>>>> [0]PETSC ERROR: #4 PCSetUp() line 932 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\interface\precon.c >>>>> [0]PETSC ERROR: #5 KSPSetUp() line 381 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >>>>> [0]PETSC ERROR: #6 KSPSolve() line 612 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >>>>> [0]PETSC ERROR: #7 SNESSolve_NEWTONLS() line 224 in E:\cygwin64\home\alireza\PETSc\src\snes\impls\ls\ls.c >>>>> [0]PETSC ERROR: #8 SNESSolve() line 4355 in E:\cygwin64\home\alireza\PETSc\src\snes\interface\snes.c >>>>> >>>>> Many thanks, >>>>> Ali >>>>> >>>>> On 8/29/2018 2:24 AM, Smith, Barry F. wrote: >>>>>> Ali, >>>>>> >>>>>> In the branch barry/feature-PCVPBJACOBI (see src/snes/examples/tutorials/ex5.c) I have implemented PCVPBJACOBI that is a point block Jacobi with variable size blocks. It has very little testing. >>>>>> >>>>>> Could you please try your code with it; you should see very very similar convergence history with this branch and the previous approach you used (the only numerical difference between the two approaches is that this one uses a dense LU factorization for each small block while the previous used a sparse factorization). This new one should also be slightly faster in the KSPSolve(). >>>>>> >>>>>> Thanks >>>>>> >>>>>> Barry >>>>>> >>>>>> >>>>>> >>>>>> >>>>>>> On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: >>>>>>> >>>>>>> "Smith, Barry F." writes: >>>>>>> >>>>>>>> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c >>>>>>> Note that this example is block Jacobi with O(1) sparse blocks per >>>>>>> process, not variable-sized point-block Jacobi which I think is what Ali >>>>>>> had in mind. >>>>>>> >>>>>>>> Please let us know if it works for you and if you have any questions or problems. >>>>>>>> >>>>>>>> Barry >>>>>>>> >>>>>>>> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >>>>>>>> >>>>>>>> Sorry for the runaround with so many emails. >>>>>>>> >>>>>>>> >>>>>>>>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>>>>>>>> >>>>>>>>> Hi, >>>>>>>>> >>>>>>>>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>>>>>>>> >>>>>>>>> Below is a part of my code. It is run serially. Any help is much appreciated. >>>>>>>>> >>>>>>>>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = SNESSetType(snes, SNESNEWTONLS); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> >>>>>>>>> SNESSetUp(snes); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> >>>>>>>>> for (i = 0; i < nLocal; i++) { >>>>>>>>> ierr = KSPGetPC(subKSP[i], &SubPc); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = PCSetType(SubPc, PCLU); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> } >>>>>>>>> ierr = SNESSolve(snes, NULL, Petsc_X); >>>>>>>>> CHKERRQ(ierr); >>>>>>>>> >>>>>>>>> >>>>>>>>> > > -- > Ali Reza Khaz?ali > Assistant Professor of Petroleum Engineering, > Department of Chemical Engineering > Isfahan University of Technology > Isfahan, Iran From mvalera-w at sdsu.edu Wed Aug 29 13:50:58 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 29 Aug 2018 11:50:58 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> Message-ID: Hi everyone, Thanks for your responses, i understand communicating on this way to this level of technicality can be hard, i still think we can work ways to solve this problem though, I can say the following at this point: - Program works without issues in any other non-gpu preconditioner, just by calling -pc_type ### . - Program works correctly with ViennaCL preconditioners with mpirun -n 1, that is on one processor. - Program breaks with every ViennaCL preconditioner when attempting any more than 1 processors. - I haven't tried other GPU preconditioners because ViennaCL gave the best performance in 1 processor before. - I have made sure the matrix type is mpiaijviennacl as it is printed right before the error log. - I am attaching what i think are the backtrace logs of the run with two cores, as i have limited experience with this kind of debugging, and i cannot make sense of what they say, please let me know if you need me to do something else. Current options i can think of are giving you permission to clone my model repo, or for you to guide me trough the process remotely, Thanks, .-.-.-.- The error i get is still: Matrix type: mpiaijviennacl Of sizes: 125 x 125 Matrix type: mpiaijviennacl Of sizes: 125 x 125 [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: No support for this operation for this object type [0]PETSC ERROR: Currently only handles ViennaCL matrices [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl [1]PETSC ERROR: #1 User provided function() line 0 in unknown file -------------------------------------------------------------------------- MPI_ABORT was invoked on rank 1 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. -------------------------------------------------------------------------- [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end [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. [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 /home/valera/petsc/src/mat/utils/gcreate.c [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ksp/interface/itfunc.c [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: Signal received [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl [0]PETSC ERROR: #4 User provided function() line 0 in unknown file [node50:32783] 1 more process has sent help message help-mpi-api.txt / mpi-abort [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp wrote: > Hi Manuel, > > as Barry said, it is hard for us to provide any help without having a more > complete picture of what is going on. > > The error you report seems to come from the AMG preconditioner in > ViennaCL. This can have many origins. Do other preconditioners run without > error? Can you run in a debugger and provide a complete backtrace? > > Thanks and best regards, > Karli > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: > >> Talked too fast, >> >> After fixing that problem, i tried more than one mpi processor and got >> the following: >> >> Matrix type: mpiaijviennacl >> Of sizes: 125 x 125 >> Matrix type: mpiaijviennacl >> Of sizes: 125 x 125 >> [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> [0]PETSC ERROR: No support for this operation for this object type >> [0]PETSC ERROR: Currently only handles ViennaCL matrices >> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT >> Date: 2018-05-31 17:31:13 +0300 >> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue >> Aug 28 16:30:02 2018 >> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >> http://saviennacl.cu> >> [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> [1]PETSC ERROR: ------------------------------ >> ------------------------------------------ >> [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, >> probably memory access out of range >> [1]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger >> [1]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >> ocumentation/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] PetscTraceBackErrorHandler line 182 >> /home/valera/petsc/src/sys/error/errtrace.c >> [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/err >> or/err.c >> [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >> http://saviennacl.cu> >> >> [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 GIT >> Date: 2018-05-31 17:31:13 +0300 >> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue >> Aug 28 16:30:02 2018 >> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >> ------------------------------------------------------------ >> -------------- >> MPI_ABORT was invoked on rank 1 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. >> ------------------------------------------------------------ >> -------------- >> [0]PETSC ERROR: ------------------------------ >> ------------------------------------------ >> [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the >> batch system) has told this process to end >> [0]PETSC ERROR: Try option -start_in_debugger or -on_error_attach_debugger >> [0]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >> ocumentation/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. >> [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >> /home/valera/petsc/src/sys/objects/tagm.c >> [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >> /home/valera/petsc/src/sys/objects/inherit.c >> [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/ >> is/interface/isreg.c >> [0]PETSC ERROR: [0] ISCreateGeneral line 668 >> /home/valera/petsc/src/vec/is/is/impls/general/general.c >> [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >> http://saviennacl.cu> >> [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> [0]PETSC ERROR: Signal received >> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT >> Date: 2018-05-31 17:31:13 +0300 >> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue >> Aug 28 16:30:02 2018 >> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >> [node50:30582] 1 more process has sent help message help-mpi-api.txt / >> mpi-abort >> [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to see >> all help / error messages >> >> >> >> It is currently running in 1 mpi processor + GPU but i would like to call >> at least 16 mpi processors + GPU to do the rest of the data management who >> is not part of the main laplacian on the mpi and the laplacian solution on >> the GPU, is this currently possible? >> >> Thanks for your help, >> >> >> >> On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > > wrote: >> >> Ok, i found the culprit and we can close this thread, >> >> The problem was a missing variable for setting the maximum columns, >> which i deleted at some point without realizing. The error message >> was too ambiguous to catch this so i had to compare with a previous >> working version of the arguments of MatSetValues, it was evident then. >> >> Good news is that i can now set the values with the viennacl types >> too, >> >> Thanks for your kind help, >> >> Manuel >> >> On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >> > wrote: >> >> >> 1) PetscMalloc() is never valid or needed in Fortran >> >> 2) there is no reason to use DMSetMatrixPreallocateOnly() >> just use DMCreateMatrix() assuming that using a DM (DMDA, >> DMPLEX, etc) is suitable for your problem. >> >> At this end we are totally guessing at what you are doing >> and so have little help we can provide. A simple, nonworking >> code that tries to do what you would need would help us a great >> deal in understanding that you are trying to do. >> >> Barry >> >> >> >> >> >> > On Aug 28, 2018, at 1:18 PM, Manuel Valera >> > wrote: >> > >> > Matthew, PetscMalloc gives the same error, >> > >> > Barry, it would be very hard for me to get the code to a >> minimum working example, i guess all i need to understand is how >> to setup a DM matrix with DMSetMatrixPreallocateOnly() instead >> of MatMPIAIJSetPreallocation() as we were doing before, is there >> a simple example who does this in Fortran? >> > >> > Is the PetscMalloc call needed? is 'call >> PetscMalloc(1,row,ierr)' a valid, compilable call to >> PetscMalloc? what other reason may there be for this error to >> happen ? >> > >> > Just remembering, that trying to setup the matrix with the >> MatAIJSetPreallocation() brings up an error to acknowledge the >> viennacl datatypes and that's why i'm trying to make this change >> on your recommendation, >> > >> > Thanks for your help, >> > >> > >> > >> > >> > >> > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >> > wrote: >> > >> > Send your code in a way we can compile and run it; it must >> be some simple issue that is hard to communicate in email. >> > >> > Barry >> > >> > >> > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >> > wrote: >> > > >> > > Hello everyone, >> > > >> > > I just had time to work on this again, and checked the code >> for errors on the matrix entries, this is the exact code i was >> using for creating the matrix without >> DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and >> it worked that way, but trying this way i get the same 'Column >> too large' error using any number at the column position of >> MatSetValues, >> > > >> > > I have set up my code to print the column argument (n) of >> MatSetValues and in this case is 7 (lower than 124), it still >> gives error, even entering a specific number in the MatSetValues >> column argument position gives the same error. >> > > >> > > So next i went back to ex.50 here: >> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/t >> utorials/ex50.c.html >> > tutorials/ex50.c.html> >> and it has a very similar structure except the PetscMalloc1() >> call, so i tried adding that and got: >> > > >> > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined >> reference to `petscmalloc1_' >> > > >> > > Any ideas on this behaviour? >> > > >> > > Thanks so much, >> > > >> > > >> > > >> > > >> > > >> > > >> > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >> > wrote: >> > > >> > > Column too large: col 10980 max 124 >> > > >> > > You need to check the code that is generating the matrix >> entries. The matrix has 124 columns but you are attempting to >> put a value at column 10980 >> > > >> > > Barry >> > > >> > > >> > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >> > wrote: >> > > > >> > > > Thanks Matthew and Barry, >> > > > >> > > > Now my code looks like: >> > > > >> > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >> > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > call MatSetFromOptions(A,ierr) >> > > > call MatSetUp(A,ierr) >> > > > [...] >> > > > call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INS >> ERT_VALUES,ierr) >> > > > [...] >> > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > >> > > > And i get a different error, now is: >> > > > >> > > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > [0]PETSC ERROR: Argument out of range >> > > > [0]PETSC ERROR: Column too large: col 10980 max 124 >> > > > [0]PETSC ERROR: See >> http://www.mcs.anl.gov/petsc/documentation/faq.html >> for >> trouble shooting. >> > > > [0]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 >> by valera Wed Aug 15 19:40:00 2018 >> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >> --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in >> /home/valera/petsc/src/mat/impls/aij/seq/aij.c >> > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >> /home/valera/petsc/src/mat/interface/matrix.c >> > > > >> > > > >> > > > Thanks again, >> > > > >> > > > >> > > > >> > > > >> > > > >> > > > >> > > > >> > > > >> > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. >> > wrote: >> > > > >> > > > Should be >> > > > >> > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > >> > > > and remove the rest. You need to set the type of Mat >> you want the DM to return BEFORE you create the matrix. >> > > > >> > > > Barry >> > > > >> > > > >> > > > >> > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >> > wrote: >> > > > > >> > > > > Ok thanks for clarifying that, i wasn't sure if there >> were different types, >> > > > > >> > > > > Here is a stripped down version of my code, it seems >> like the preallocation is working now since the matrix >> population part is working without problem, but here it is for >> illustration purposes: >> > > > > >> > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >> > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > call MatSetFromOptions(A,ierr) >> > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > call MatSetUp(A,ierr) >> > > > > [...] >> > > > > call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INS >> ERT_VALUES,ierr) >> > > > > [...] >> > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > >> > > > > Adding the first line there did the trick, >> > > > > >> > > > > Now the problem seems to be the program is not >> recognizing the matrix as ViennaCL type when i try with more >> than one processor, i get now: >> > > > > >> > > > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > > [0]PETSC ERROR: No support for this operation for this >> object type >> > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >> > > > > [0]PETSC ERROR: See >> http://www.mcs.anl.gov/petsc/documentation/faq.html >> for >> trouble shooting. >> > > > > [0]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >> node50 by valera Wed Aug 15 14:44:22 2018 >> > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >> --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> >> > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >> /home/valera/petsc/src/ksp/pc/interface/precon.c >> > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >> > > > > >> > > > > When running with: >> > > > > >> > > > > mpirun -n 1 ./gcmLEP.GPU >> tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >> -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl >> -pc_type saviennacl -log_view >> > > > > >> > > > > >> > > > > Thanks, >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley >> > wrote: >> > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >> > wrote: >> > > > > It seems to be resumed on: I do not know how to >> preallocate a DM Matrix correctly. >> > > > > >> > > > > There is only one matrix type, Mat. There are no >> separate DM matrices. A DM can create a matrix for you >> > > > > using DMCreateMatrix(), but that is a Mat and it is >> preallocated correctly. I am not sure what you are doing. >> > > > > >> > > > > Thanks, >> > > > > >> > > > > Matt >> > > > > >> > > > > The interesting part is that it only breaks when i need >> to populate a GPU matrix from MPI, so kudos on that, but it >> seems i need to do better on my code to get this setup working, >> > > > > >> > > > > Any help would be appreciated, >> > > > > >> > > > > Thanks, >> > > > > >> > > > > >> > > > > >> > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >> > wrote: >> > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >> > wrote: >> > > > > Thanks Matthew, >> > > > > >> > > > > I try to do that when calling: >> > > > > >> > > > > call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > >> > > > > But i am not aware on how to do this for the DM if it >> needs something more specific/different, >> > > > > >> > > > > The error says that your preallocation is wrong for the >> values you are putting in. The DM does not control either, >> > > > > so I do not understand your email. >> > > > > >> > > > > Thanks, >> > > > > >> > > > > Matt >> > > > > >> > > > > Thanks, >> > > > > >> > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >> > wrote: >> > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >> > wrote: >> > > > > Hello PETSc devs, >> > > > > >> > > > > I am running into an error when trying to use the >> MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs >> for MATSEQAIJVIENNACL type in one processor. The error happens >> when calling MatSetValues for this specific configuration. It >> does not occur when using MPI DMMatrix types only. >> > > > > >> > > > > The DM properly preallocates the matrix. I am assuming >> you do not here. >> > > > > >> > > > > Matt >> > > > > >> > > > > Any help will be appreciated, >> > > > > >> > > > > Thanks, >> > > > > >> > > > > >> > > > > >> > > > > My program call: >> > > > > >> > > > > mpirun -n 2 ./gcmLEP.GPU >> tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >> -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl >> -pc_type saviennacl -log_view >> > > > > >> > > > > >> > > > > The error (repeats after each MatSetValues call): >> > > > > >> > > > > [1]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > > [1]PETSC ERROR: Argument out of range >> > > > > [1]PETSC ERROR: Inserting a new nonzero at global >> row/column (75, 50) into matrix >> > > > > [1]PETSC ERROR: See >> http://www.mcs.anl.gov/petsc/documentation/faq.html >> for >> trouble shooting. >> > > > > [1]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >> node50 by valera Wed Aug 15 13:10:44 2018 >> > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >> --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >> > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >> /home/valera/petsc/src/mat/interface/matrix.c >> > > > > >> > > > > >> > > > > My Code structure: >> > > > > >> > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > call MatSetFromOptions(A,ierr) >> > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >> > > > > if (numprocs > 1) then ! set matrix type parallel >> > > > > ! Get local size >> > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >> > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) >> > > > > call VecDestroy(Tmpnat,ierr) >> > > > > ! Set matrix >> > > > > #ifdef GPU >> > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >> > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > print*,'SETTING GPU TYPES' >> > > > > #else >> > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >> > > > > call DMSetMatType(daDummy,VECMPI,ierr) >> > > > > call MatSetType(A,MATMPIAIJ,ierr)! >> > > > > #endif >> > > > > call >> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > else ! set matrix type sequential >> > > > > #ifdef GPU >> > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >> > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >> > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >> > > > > print*,'SETTING GPU TYPES' >> > > > > #else >> > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >> > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >> > > > > call MatSetType(A,MATSEQAIJ,ierr) >> > > > > #endif >> > > > > call MatSetUp(A,ierr) >> > > > > call >> getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >> > > > > >> > > > > do k=zstart,zend-1 >> > > > > do j=ystart,yend-1 >> > > > > do i=xstart,xend-1 >> > > > > [..] >> > > > > call >> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INS >> ERT_VALUES,ierr) >> > > > > [..] >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > -- >> > > > > 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 >> > > > > >> > > > > https://www.cse.buffalo.edu/~knepley/ >> >> > > > > >> > > > > >> > > > > >> > > > > -- >> > > > > 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 >> > > > > >> > > > > https://www.cse.buffalo.edu/~knepley/ >> >> > > > > >> > > > > >> > > > > >> > > > > -- >> > > > > 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 >> > > > > >> > > > > https://www.cse.buffalo.edu/~knepley/ >> >> > > > > >> > > > >> > > > >> > > >> > > >> > >> > >> >> >> >> -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: backt-2.log Type: text/x-log Size: 3909 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: backt.log Type: text/x-log Size: 3623 bytes Desc: not available URL: From arkhazali at cc.iut.ac.ir Wed Aug 29 14:08:41 2018 From: arkhazali at cc.iut.ac.ir (Ali Reza Khaz'ali) Date: Wed, 29 Aug 2018 23:38:41 +0430 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: <87a7p558ce.fsf@jedbrown.org> References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> <7b093784-8da8-1b00-9f31-a327d86882ab@cc.iut.ac.ir> <87in3t5a0j.fsf@jedbrown.org> <82f16e58-ab8e-2ab8-eb6b-26b9bd8e820e@cc.iut.ac.ir> <87a7p558ce.fsf@jedbrown.org> Message-ID: Thanks again, > You might want to use a memory profiler to see if you have important > leaks. See comment below about destroying objects and PETSc memory > logging. That's a very good suggestion. I'll do it. > This matrix takes just a little over 100 MB (only about 35 MB of which > is needed). If this code is using a lot more memory than that, you > should use a memory profiler to find out where (e.g., some data > structures in your code). The memory usage was high for the previous (and wrong) one with bjacobi/ilu.? My code with vpbjacobi preconditioner only requires 150K, which as you stated, most of it is not required by PETSc. > All of your time is in function and Jacobian evaluation. > The entire linear solve is less than 50 milliseconds. Thanks for your comment. You are right. The Jacobian construction involves about 40K lines of code, and a lot of phase equilibrium calculations, which are very time intensive. > It looks like you have forgotten to destroy all of your objects. If you > clean up after yourself, you'll also see the totaly memory used by each > of the PETSc classes that you use. That is because of PetscLogView was placed before the destroy functions. I moved it after them, and here is the new log: (additionally, this is the log of one time step only, so all of the objects won't be destroyed before all time steps have been finished) SNES Object: 1 MPI processes ? type: newtonls ? maximum iterations=2000, maximum function evaluations=2000 ? tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 ? total number of linear solver iterations=3 ? total number of function evaluations=2 ? norm schedule ALWAYS ? SNESLineSearch Object: 1 MPI processes ??? type: bt ????? interpolation: cubic ????? alpha=1.000000e-04 ??? maxstep=1.000000e+08, minlambda=1.000000e-12 ??? tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 ??? maximum iterations=40 ? KSP Object: 1 MPI processes ??? type: gmres ????? restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement ????? happy breakdown tolerance 1e-30 ??? maximum iterations=5000, initial guess is zero ??? tolerances:? relative=1e-05, absolute=1e-06, divergence=10000. ??? left preconditioning ??? using PRECONDITIONED norm type for convergence test ? PC Object: 1 MPI processes ??? type: vpbjacobi ??? linear system matrix = precond matrix: ??? Mat Object: 1 MPI processes ????? type: seqaij ????? rows=108000, cols=108000 ????? total: nonzeros=2868000, allocated nonzeros=8640000 ????? total number of mallocs used during MatSetValues calls =0 ??????? not using I-node routines ************************************************************************************************************************ ***???????????? WIDEN YOUR WINDOW TO 120 CHARACTERS.? Use 'enscript -r -fCourier9' to print this document??????????? *** ************************************************************************************************************************ ---------------------------------------------- PETSc Performance Summary: ---------------------------------------------- E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a? named ALIREZA-PC with 1 processor, by AliReza Wed Aug 29 23:33:39 2018 Using Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5? GIT Date: 2018-08-28 19:19:26 -0500 ???????????????????????? Max?????? Max/Min???? Avg?????? Total Time (sec):?????????? 1.190e+02???? 1.000?? 1.190e+02 Objects:????????????? 3.600e+01???? 1.000?? 3.600e+01 Flop:???????????????? 2.867e+07???? 1.000?? 2.867e+07? 2.867e+07 Flop/sec:???????????? 2.408e+05???? 1.000?? 2.408e+05? 2.408e+05 MPI Messages:???????? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 MPI Message Lengths:? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 MPI Reductions:?????? 0.000e+00???? 0.000 Flop counting convention: 1 flop = 1 real number operation of type (multiply/divide/add/subtract) ??????????????????????????? e.g., VecAXPY() for real vectors of length N --> 2N flop ??????????????????????????? and VecAXPY() for complex vectors of length N --> 8N flop Summary of Stages:?? ----- Time ------? ----- Flop ------? --- Messages ---? -- Message Lengths --? -- Reductions -- ??????????????????????? Avg???? %Total???? Avg???? %Total??? Count %Total???? Avg???????? %Total??? Count?? %Total ?0:????? Main Stage: 1.1905e+02 100.0%? 2.8668e+07 100.0% 0.000e+00?? 0.0%? 0.000e+00??????? 0.0%? 0.000e+00?? 0.0% ------------------------------------------------------------------------------------------------------------------------ See the 'Profiling' chapter of the users' manual for details on interpreting output. Phase summary info: ?? Count: number of times phase was executed ?? Time and Flop: Max - maximum over all processors ????????????????? Ratio - ratio of maximum to minimum over all processors ?? Mess: number of messages sent ?? AvgLen: average message length (bytes) ?? Reduct: number of global reductions ?? Global: entire computation ?? Stage: stages of a computation. Set stages with PetscLogStagePush() and PetscLogStagePop(). ????? %T - percent time in this phase???????? %F - percent flop in this phase ????? %M - percent messages in this phase???? %L - percent message lengths in this phase ????? %R - percent reductions in this phase ?? Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time over all processors) ------------------------------------------------------------------------------------------------------------------------ Event??????????????? Count????? Time (sec) Flop????????????????????????????? --- Global ---? --- Stage ---- Total ?????????????????? Max Ratio? Max???? Ratio?? Max? Ratio? Mess AvgLen? Reduct? %T %F %M %L %R? %T %F %M %L %R Mflop/s ------------------------------------------------------------------------------------------------------------------------ --- Event Stage 0: Main Stage PetscBarrier?????????? 1 1.0 2.1382e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 BuildTwoSidedF???????? 2 1.0 4.2337e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 SNESSolve????????????? 1 1.0 1.0010e+02 1.0 2.87e+07 1.0 0.0e+00 0.0e+00 0.0e+00 84100? 0? 0? 0? 84100? 0? 0? 0???? 0 SNESFunctionEval?????? 2 1.0 5.2605e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 SNESJacobianEval?????? 1 1.0 9.4788e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 80? 0? 0? 0? 0? 80? 0? 0? 0? 0???? 0 SNESLineSearch???????? 1 1.0 2.6283e+00 1.0 6.82e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 2 24? 0? 0? 0?? 2 24? 0? 0? 0???? 3 VecDot???????????????? 1 1.0 1.8261e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0? 1183 VecMDot??????????????? 3 1.0 8.1381e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0? 1592 VecNorm??????????????? 7 1.0 6.5849e-03 1.0 1.51e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0?? 230 VecScale?????????????? 4 1.0 1.6208e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 2665 VecCopy??????????????? 3 1.0 4.4561e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecSet???????????????? 2 1.0 1.4369e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecAXPY??????????????? 1 1.0 1.5823e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0? 1365 VecWAXPY?????????????? 1 1.0 1.9501e-04 1.0 1.08e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0?? 554 VecMAXPY?????????????? 4 1.0 7.7190e-04 1.0 1.94e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 7? 0? 0? 0?? 0? 7? 0? 0? 0? 2518 VecAssemblyBegin?????? 2 1.0 7.9970e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecAssemblyEnd???????? 2 1.0 1.2402e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecReduceArith???????? 2 1.0 2.8567e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 1512 VecReduceComm????????? 1 1.0 5.1318e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 VecNormalize?????????? 4 1.0 4.6357e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0? 2796 MatMult??????????????? 4 1.0 1.6927e-02 1.0 2.25e+07 1.0 0.0e+00 0.0e+00 0.0e+00? 0 79? 0? 0? 0?? 0 79? 0? 0? 0? 1330 MatAssemblyBegin?????? 2 1.0 8.5529e-07 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatAssemblyEnd???????? 2 1.0 2.4032e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatZeroEntries???????? 1 1.0 2.8857e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 MatView??????????????? 1 1.0 3.3998e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 KSPSetUp?????????????? 1 1.0 1.2325e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 KSPSolve?????????????? 1 1.0 3.7389e-02 1.0 2.16e+07 1.0 0.0e+00 0.0e+00 0.0e+00? 0 75? 0? 0? 0?? 0 75? 0? 0? 0?? 579 KSPGMRESOrthog???????? 3 1.0 1.3552e-03 1.0 2.59e+06 1.0 0.0e+00 0.0e+00 0.0e+00? 0? 9? 0? 0? 0?? 0? 9? 0? 0? 0? 1913 PCSetUp??????????????? 1 1.0 1.4842e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 PCApply??????????????? 4 1.0 3.1607e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 ------------------------------------------------------------------------------------------------------------------------ Memory usage is given in bytes: Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. Reports information only for process 0. --- Event Stage 0: Main Stage ??????????????? SNES???? 1????????????? 1???????? 1372???? 0. ????????????? DMSNES???? 1????????????? 1????????? 672???? 0. ????? SNESLineSearch???? 1????????????? 1???????? 1000???? 0. ????????????? Vector??? 20???????????? 20???? 17313120???? 0. ????????????? Matrix???? 1????????????? 1??? 105843212???? 0. ??? Distributed Mesh???? 2????????????? 2???????? 9504???? 0. ?? Star Forest Graph???? 4????????????? 4???????? 3200???? 0. ???? Discrete System???? 2????????????? 2???????? 1856???? 0. ?????? Krylov Solver???? 1????????????? 1??????? 18416???? 0. ???? DMKSP interface???? 1????????????? 1????????? 656???? 0. ????? Preconditioner???? 1????????????? 1????????? 832???? 0. ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. ======================================================================================================================== Average time to get PetscTime(): 0. #PETSc Option Table entries: -ksp_atol 1e-6 -ksp_rtol 1e-5 -snes_rtol 1e-4 -sub_ksp_type preonly -sub_pc_factor_mat_solver_type mkl_pardiso -sub_pc_type lu #End of PETSc Option Table entries Compiled without FORTRAN kernels Compiled with full precision matrices (default) sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 sizeof(PetscScalar) 8 sizeof(PetscInt) 4 Configure options: --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl --with-hypre-incl ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdrive/E/Program_Fi les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int el64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debugging=0 --with-blas -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 -Qopenmp" ----------------------------------------- Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit Using PETSc directory: /home/alireza/PetscGit Using PETSc arch: ----------------------------------------- Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl -O2 -MT -wd4996 -Qopenmp Using Fortran compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp -fpp ----------------------------------------- Using include paths: -I/home/alireza/PetscGit/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include -I/cygdrive/E/hypre-2.11.2/ Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include ----------------------------------------- Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort Using libraries: -L/home/alireza/PetscGit/lib -L/home/alireza/PetscGit/lib -lpetsc /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib /cygdrive/E/Trilinos-master/Bins/lib /ml.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Gdi32.lib User32.lib ?Advapi32.lib Kernel32.lib Ws2_32.lib ----------------------------------------- Many thanks Ali > >> ======================================================================================================================== >> Average time to get PetscTime(): 8.55292e-08 >> #PETSc Option Table entries: >> -ksp_atol 1e-6 >> -ksp_rtol 1e-5 >> -snes_rtol 1e-4 >> -sub_ksp_type preonly >> -sub_pc_factor_mat_solver_type mkl_pardiso >> -sub_pc_type lu >> #End of PETSc Option Table entries >> Compiled without FORTRAN kernels >> Compiled with full precision matrices (default) >> sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 >> sizeof(PetscScalar) 8 sizeof(PetscInt) 4 >> Configure options: --prefix=/home/alireza/PetscGit >> --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl >> --with-hypre-incl >> ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include >> --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >> --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in >> clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib >> ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" >> --with-mpi-include=/cygdrive/E/Program_Fi >> les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >> --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int >> el64/lib/impi.lib >> --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe >> --with-debugging=0 --with-blas >> -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool >> s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" >> -FFLAGS="-MT -O2 -Qopenmp" >> ----------------------------------------- >> Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC >> Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit >> Using PETSc directory: /home/alireza/PetscGit >> Using PETSc arch: >> ----------------------------------------- >> >> Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >> -O2 -MT -wd4996 -Qopenmp >> Using Fortran compiler: >> /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp >> -fpp >> ----------------------------------------- >> >> Using include paths: -I/home/alireza/PetscGit/include >> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include >> -I/cygdrive/E/hypre-2.11.2/ >> Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include >> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >> ----------------------------------------- >> >> Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >> Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe >> ifort >> Using libraries: -L/home/alireza/PetscGit/lib >> -L/home/alireza/PetscGit/lib -lpetsc >> /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >> /cygdrive/E/Trilinos-master/Bins/lib >> /ml.lib >> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and >> _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib >> Gdi32.lib User32.lib >> ?Advapi32.lib Kernel32.lib Ws2_32.lib >> ----------------------------------------- >> >> >> >> >> >> On 8/29/2018 10:29 PM, Jed Brown wrote: >>> This is bjacobi/lu, not vpbjacobi. >>> >>> How are you measuring memory usage? See a couple inline comments below. >>> >>> Ali Reza Khaz'ali writes: >>> >>>> I noticed that I forgot to include the log for 10x10x5 system. Here it is: >>>> >>>> >>>> 1 MPI processes >>>> ? type: newtonls >>>> ? maximum iterations=2000, maximum function evaluations=2000 >>>> ? tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 >>>> ? total number of linear solver iterations=1 >>>> ? total number of function evaluations=2 >>>> ? norm schedule ALWAYS >>>> ? SNESLineSearch Object: 1 MPI processes >>>> ??? type: bt >>>> ????? interpolation: cubic >>>> ????? alpha=1.000000e-04 >>>> ??? maxstep=1.000000e+08, minlambda=1.000000e-12 >>>> ??? tolerances: relative=1.000000e-08, absolute=1.000000e-15, >>>> lambda=1.000000e-08 >>>> ??? maximum iterations=40 >>>> ? KSP Object: 1 MPI processes >>>> ??? type: gmres >>>> ????? restart=30, using Classical (unmodified) Gram-Schmidt >>>> Orthogonalization with no iterative refinement >>>> ????? happy breakdown tolerance 1e-30 >>>> ??? maximum iterations=5000, initial guess is zero >>>> ??? tolerances:? relative=1e-05, absolute=1e-06, divergence=10000. >>>> ??? left preconditioning >>>> ??? using PRECONDITIONED norm type for convergence test >>>> ? PC Object: 1 MPI processes >>>> ??? type: bjacobi >>>> ????? number of blocks = 1 >>>> ????? Local solve is same for all blocks, in the following KSP and PC >>>> objects: >>>> ????? KSP Object: (sub_) 1 MPI processes >>>> ??????? type: preonly >>>> ??????? maximum iterations=10000, initial guess is zero >>>> ??????? tolerances:? relative=1e-05, absolute=1e-50, divergence=10000. >>>> ??????? left preconditioning >>>> ??????? using NONE norm type for convergence test >>>> ????? PC Object: (sub_) 1 MPI processes >>>> ??????? type: lu >>>> ????????? out-of-place factorization >>>> ????????? tolerance for zero pivot 2.22045e-14 >>>> ????????? matrix ordering: nd >>>> ????????? factor fill ratio given 0., needed 0. >>>> ??????????? Factored matrix follows: >>>> ????????????? Mat Object: 1 MPI processes >>>> ??????????????? type: mkl_pardiso >>>> ??????????????? rows=6000, cols=6000 >>>> ??????????????? package used to perform factorization: mkl_pardiso >>>> ??????????????? total: nonzeros=150000, allocated nonzeros=150000 >>>> ??????????????? total number of mallocs used during MatSetValues calls =0 >>>> ????????????????? MKL_PARDISO run parameters: >>>> ????????????????? MKL_PARDISO phase:???????????? 33 >>>> ????????????????? MKL_PARDISO iparm[1]:???? 1 >>>> ????????????????? MKL_PARDISO iparm[2]:???? 2 >>>> ????????????????? MKL_PARDISO iparm[3]:???? 2 >>>> ????????????????? MKL_PARDISO iparm[4]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[5]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[6]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[7]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[8]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[9]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[10]:???? 13 >>>> ????????????????? MKL_PARDISO iparm[11]:???? 1 >>>> ????????????????? MKL_PARDISO iparm[12]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[13]:???? 1 >>>> ????????????????? MKL_PARDISO iparm[14]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[15]:???? 11228 >>>> ????????????????? MKL_PARDISO iparm[16]:???? 7563 >>>> ????????????????? MKL_PARDISO iparm[17]:???? 37035 >>>> ????????????????? MKL_PARDISO iparm[18]:???? 4204238 >>>> ????????????????? MKL_PARDISO iparm[19]:???? 2659 >>>> ????????????????? MKL_PARDISO iparm[20]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[21]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[22]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[23]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[24]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[25]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[26]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[27]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[28]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[29]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[30]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[31]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[32]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[33]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[34]:???? -1 >>>> ????????????????? MKL_PARDISO iparm[35]:???? 1 >>>> ????????????????? MKL_PARDISO iparm[36]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[37]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[38]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[39]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[40]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[41]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[42]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[43]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[44]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[45]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[46]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[47]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[48]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[49]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[50]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[51]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[52]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[53]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[54]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[55]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[56]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[57]:???? -1 >>>> ????????????????? MKL_PARDISO iparm[58]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[59]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[60]:???? 0 >>>> ????????????????? MKL_PARDISO iparm[61]:???? 11228 >>>> ????????????????? MKL_PARDISO iparm[62]:???? 7868 >>>> ????????????????? MKL_PARDISO iparm[63]:???? 3629 >>>> ????????????????? MKL_PARDISO iparm[64]:???? 0 >>>> ????????????????? MKL_PARDISO maxfct:???? 1 >>>> ????????????????? MKL_PARDISO mnum:???? 1 >>>> ????????????????? MKL_PARDISO mtype:???? 11 >>>> ????????????????? MKL_PARDISO n:???? 6000 >>>> ????????????????? MKL_PARDISO nrhs:???? 1 >>>> ????????????????? MKL_PARDISO msglvl:???? 0 >>>> ??????? linear system matrix = precond matrix: >>>> ??????? Mat Object: 1 MPI processes >>>> ????????? type: seqaij >>>> ????????? rows=6000, cols=6000 >>>> ????????? total: nonzeros=150000, allocated nonzeros=480000 >>>> ????????? total number of mallocs used during MatSetValues calls =0 >>>> ??????????? not using I-node routines >>>> ??? linear system matrix = precond matrix: >>>> ??? Mat Object: 1 MPI processes >>>> ????? type: seqaij >>>> ????? rows=6000, cols=6000 >>>> ????? total: nonzeros=150000, allocated nonzeros=480000 >>> Note that you preallocated more than necessary here. >>> >>>> ????? total number of mallocs used during MatSetValues calls =0 >>>> ??????? not using I-node routines >>>> ************************************************************************************************************************ >>>> ***???????????? WIDEN YOUR WINDOW TO 120 CHARACTERS.? Use 'enscript -r >>>> -fCourier9' to print this document??????????? *** >>>> ************************************************************************************************************************ >>>> >>>> ---------------------------------------------- PETSc Performance >>>> Summary: ---------------------------------------------- >>>> >>>> E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe >>>> on a? named ALIREZA-PC with 1 processor, by AliReza Wed Aug 29 22:12:30 2018 >>>> Using Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5? GIT Date: >>>> 2018-08-28 19:19:26 -0500 >>>> >>>> ???????????????????????? Max?????? Max/Min???? Avg?????? Total >>>> Time (sec):?????????? 3.373e+01???? 1.000?? 3.373e+01 >>>> Objects:????????????? 3.300e+01???? 1.000?? 3.300e+01 >>>> Flop:???????????????? 7.500e+05???? 1.000?? 7.500e+05? 7.500e+05 >>>> Flop/sec:???????????? 2.224e+04???? 1.000?? 2.224e+04? 2.224e+04 >>>> MPI Messages:???????? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 >>>> MPI Message Lengths:? 0.000e+00???? 0.000?? 0.000e+00? 0.000e+00 >>>> MPI Reductions:?????? 0.000e+00???? 0.000 >>>> >>>> Flop counting convention: 1 flop = 1 real number operation of type >>>> (multiply/divide/add/subtract) >>>> ??????????????????????????? e.g., VecAXPY() for real vectors of length >>>> N --> 2N flop >>>> ??????????????????????????? and VecAXPY() for complex vectors of length >>>> N --> 8N flop >>>> >>>> Summary of Stages:?? ----- Time ------? ----- Flop ------? --- Messages >>>> ---? -- Message Lengths --? -- Reductions -- >>>> ??????????????????????? Avg???? %Total???? Avg???? %Total Count >>>> %Total???? Avg???????? %Total??? Count?? %Total >>>> ?0:????? Main Stage: 3.3730e+01 100.0%? 7.5000e+05 100.0% 0.000e+00 >>>> 0.0%? 0.000e+00??????? 0.0%? 0.000e+00?? 0.0% >>>> >>>> ------------------------------------------------------------------------------------------------------------------------ >>>> See the 'Profiling' chapter of the users' manual for details on >>>> interpreting output. >>>> Phase summary info: >>>> ?? Count: number of times phase was executed >>>> ?? Time and Flop: Max - maximum over all processors >>>> ????????????????? Ratio - ratio of maximum to minimum over all processors >>>> ?? Mess: number of messages sent >>>> ?? AvgLen: average message length (bytes) >>>> ?? Reduct: number of global reductions >>>> ?? Global: entire computation >>>> ?? Stage: stages of a computation. Set stages with PetscLogStagePush() >>>> and PetscLogStagePop(). >>>> ????? %T - percent time in this phase???????? %F - percent flop in this >>>> phase >>>> ????? %M - percent messages in this phase???? %L - percent message >>>> lengths in this phase >>>> ????? %R - percent reductions in this phase >>>> ?? Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time >>>> over all processors) >>>> ------------------------------------------------------------------------------------------------------------------------ >>>> Event??????????????? Count????? Time (sec) >>>> Flop????????????????????????????? --- Global ---? --- Stage ---- Total >>>> ?????????????????? Max Ratio? Max???? Ratio?? Max? Ratio? Mess AvgLen >>>> Reduct? %T %F %M %L %R? %T %F %M %L %R Mflop/s >>>> ------------------------------------------------------------------------------------------------------------------------ >>>> >>>> --- Event Stage 0: Main Stage >>>> >>>> BuildTwoSidedF???????? 2 1.0 7.9003e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> SNESSolve????????????? 1 1.0 7.3396e+00 1.0 7.50e+05 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00 22100? 0? 0? 0? 22100? 0? 0? 0???? 0 >>>> SNESFunctionEval?????? 2 1.0 3.8894e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> SNESJacobianEval?????? 1 1.0 5.1611e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00 15? 0? 0? 0? 0? 15? 0? 0? 0? 0???? 0 >>> Most of the time here is spent in your code computing the Jacobian, not >>> in the solver. >>> >>>> SNESLineSearch???????? 1 1.0 1.7655e-02 1.0 3.60e+05 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0 48? 0? 0? 0?? 0 48? 0? 0? 0??? 20 >>>> VecDot???????????????? 1 1.0 1.1546e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0? 1039 >>>> VecMDot??????????????? 1 1.0 2.3093e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0?? 520 >>>> VecNorm??????????????? 5 1.0 4.9769e-01 1.0 6.00e+04 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 1? 8? 0? 0? 0?? 1? 8? 0? 0? 0???? 0 >>>> VecScale?????????????? 2 1.0 9.3291e-03 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 1 >>>> VecCopy??????????????? 3 1.0 2.3093e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> VecSet???????????????? 4 1.0 1.5395e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> VecAXPY??????????????? 1 1.0 2.5734e-02 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 2? 0? 0? 0?? 0? 2? 0? 0? 0???? 0 >>>> VecWAXPY?????????????? 1 1.0 1.3257e-05 1.0 6.00e+03 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 1? 0? 0? 0?? 0? 1? 0? 0? 0?? 453 >>>> VecMAXPY?????????????? 2 1.0 2.3521e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0? 1020 >>>> VecAssemblyBegin?????? 2 1.0 7.9040e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> VecAssemblyEnd???????? 2 1.0 1.7961e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> VecReduceArith???????? 2 1.0 9.8359e-06 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0? 2440 >>>> VecReduceComm????????? 1 1.0 4.7041e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> VecNormalize?????????? 2 1.0 9.3552e-03 1.0 3.60e+04 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 5? 0? 0? 0?? 0? 5? 0? 0? 0???? 4 >>>> MatMult??????????????? 2 1.0 4.4860e-04 1.0 5.88e+05 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0 78? 0? 0? 0?? 0 78? 0? 0? 0? 1311 >>>> MatSolve?????????????? 2 1.0 1.7876e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 >>>> MatLUFactorSym???????? 1 1.0 7.6157e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 >>>> MatLUFactorNum???????? 1 1.0 6.5977e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 2? 0? 0? 0? 0?? 2? 0? 0? 0? 0???? 0 >>>> MatAssemblyBegin?????? 2 1.0 0.0000e+00 0.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> MatAssemblyEnd???????? 2 1.0 1.2962e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> MatGetRowIJ??????????? 1 1.0 1.1534e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> MatGetOrdering???????? 1 1.0 5.1809e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> MatZeroEntries???????? 1 1.0 1.1298e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> MatView??????????????? 3 1.0 3.8344e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 >>>> KSPSetUp?????????????? 2 1.0 3.2843e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 0? 0? 0? 0?? 0? 0? 0? 0? 0???? 0 >>>> KSPSolve?????????????? 1 1.0 1.6414e+00 1.0 3.78e+05 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 5 50? 0? 0? 0?? 5 50? 0? 0? 0???? 0 >>>> KSPGMRESOrthog???????? 1 1.0 5.9015e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 0? 3? 0? 0? 0?? 0? 3? 0? 0? 0?? 407 >>>> PCSetUp??????????????? 2 1.0 1.4267e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 >>>> PCSetUpOnBlocks??????? 1 1.0 1.4266e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 4? 0? 0? 0? 0?? 4? 0? 0? 0? 0???? 0 >>>> PCApply??????????????? 2 1.0 1.7882e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>> 0.0e+00? 1? 0? 0? 0? 0?? 1? 0? 0? 0? 0???? 0 >>>> ------------------------------------------------------------------------------------------------------------------------ >>>> >>>> Memory usage is given in bytes: >>>> >>>> Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. >>>> Reports information only for process 0. >>>> >>>> --- Event Stage 0: Main Stage >>>> >>>> ??????????????? SNES???? 1????????????? 0??????????? 0???? 0. >>>> ????????????? DMSNES???? 1????????????? 0??????????? 0???? 0. >>>> ????? SNESLineSearch???? 1????????????? 0??????????? 0???? 0. >>>> ????????????? Vector??? 12????????????? 0??????????? 0???? 0. >>>> ????????????? Matrix???? 2????????????? 0??????????? 0???? 0. >>>> ??? Distributed Mesh???? 2????????????? 0??????????? 0???? 0. >>>> ?????????? Index Set???? 2????????????? 0??????????? 0???? 0. >>>> ?? Star Forest Graph???? 4????????????? 0??????????? 0???? 0. >>>> ???? Discrete System???? 2????????????? 0??????????? 0???? 0. >>>> ?????? Krylov Solver???? 2????????????? 0??????????? 0???? 0. >>>> ???? DMKSP interface???? 1????????????? 0??????????? 0???? 0. >>>> ????? Preconditioner???? 2????????????? 0??????????? 0???? 0. >>>> ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. >>>> ======================================================================================================================== >>>> Average time to get PetscTime(): 4.27647e-08 >>>> #PETSc Option Table entries: >>>> -ksp_atol 1e-6 >>>> -ksp_rtol 1e-5 >>>> -snes_rtol 1e-4 >>>> -sub_ksp_type preonly >>>> -sub_pc_factor_mat_solver_type mkl_pardiso >>>> -sub_pc_type lu >>>> #End of PETSc Option Table entries >>>> Compiled without FORTRAN kernels >>>> Compiled with full precision matrices (default) >>>> sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 >>>> sizeof(PetscScalar) 8 sizeof(PetscInt) 4 >>>> Configure options: --prefix=/home/alireza/PetscGit >>>> --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl >>>> --with-hypre-incl >>>> ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include >>>> --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >>>> --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in >>>> clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib >>>> ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" >>>> --with-mpi-include=/cygdrive/E/Program_Fi >>>> les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >>>> --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int >>>> el64/lib/impi.lib >>>> --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe >>>> --with-debugging=0 --with-blas >>>> -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>>> --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool >>>> s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>>> -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" >>>> -FFLAGS="-MT -O2 -Qopenmp" >>>> ----------------------------------------- >>>> Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC >>>> Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit >>>> Using PETSc directory: /home/alireza/PetscGit >>>> Using PETSc arch: >>>> ----------------------------------------- >>>> >>>> Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >>>> -O2 -MT -wd4996 -Qopenmp >>>> Using Fortran compiler: >>>> /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp >>>> -fpp >>>> ----------------------------------------- >>>> >>>> Using include paths: -I/home/alireza/PetscGit/include >>>> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include >>>> -I/cygdrive/E/hypre-2.11.2/ >>>> Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include >>>> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >>>> ----------------------------------------- >>>> >>>> Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >>>> Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe >>>> ifort >>>> Using libraries: -L/home/alireza/PetscGit/lib >>>> -L/home/alireza/PetscGit/lib -lpetsc >>>> /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >>>> /cygdrive/E/Trilinos-master/Bins/lib >>>> /ml.lib >>>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and >>>> _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib >>>> Gdi32.lib User32.lib >>>> ?Advapi32.lib Kernel32.lib Ws2_32.lib >>>> ----------------------------------------- >>>> >>>> >>>> >>>> On 8/29/2018 7:40 PM, Smith, Barry F. wrote: >>>>> You need to add the line >>>>> >>>>> ierr = MatSetVariableBlockSizes(J,3,lens);CHKERRQ(ierr); >>>>> >>>>> with the number of blocks replacing 3 and the sizes of each block in lens >>>>> >>>>> Barry >>>>> >>>>> >>>>>> On Aug 29, 2018, at 4:27 AM, Ali Reza Khaz'ali wrote: >>>>>> >>>>>> Barry, >>>>>> >>>>>> Thanks a lot for your efforts. Using PCVPBJACOBI causes SNESSolve to throw the following error (the code and the system being simulated is the same, just PCBJACOBI changed to PCVPBJACOBI): >>>>>> >>>>>> >>>>>> [0]PETSC ERROR: --------------------- Error Message --------------------------------------- >>>>>> ----------------------- >>>>>> [0]PETSC ERROR: Nonconforming object sizes >>>>>> [0]PETSC ERROR: Total blocksizes 0 doesn't match number matrix rows 108000 >>>>>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >>>>>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5 GIT Date: 2018-08-28 19:19:26 -0500 >>>>>> [0]PETSC ERROR: E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a named ALIREZA-PC by AliReza Wed Aug 29 13:46:38 2018 >>>>>> [0]PETSC ERROR: Configure options --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl -- >>>>>> with-hypre-include=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos >>>>>> -master/Bins/include --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdri >>>>>> ve/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/ >>>>>> windows/mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debuggin >>>>>> g=0 --with-blas-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_ >>>>>> x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 - >>>>>> Qopenmp" >>>>>> [0]PETSC ERROR: #1 MatInvertVariableBlockDiagonal_SeqAIJ() line 1569 in E:\cygwin64\home\alireza\PETSc\src\mat\impls\aij\seq\aij.c >>>>>> [0]PETSC ERROR: #2 MatInvertVariableBlockDiagonal() line 10482 in E:\cygwin64\home\alireza\PETSc\src\mat\interface\matrix.c >>>>>> [0]PETSC ERROR: #3 PCSetUp_VPBJacobi() line 120 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\impls\vpbjacobi\vpbjacobi.c >>>>>> [0]PETSC ERROR: #4 PCSetUp() line 932 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\interface\precon.c >>>>>> [0]PETSC ERROR: #5 KSPSetUp() line 381 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >>>>>> [0]PETSC ERROR: #6 KSPSolve() line 612 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >>>>>> [0]PETSC ERROR: #7 SNESSolve_NEWTONLS() line 224 in E:\cygwin64\home\alireza\PETSc\src\snes\impls\ls\ls.c >>>>>> [0]PETSC ERROR: #8 SNESSolve() line 4355 in E:\cygwin64\home\alireza\PETSc\src\snes\interface\snes.c >>>>>> >>>>>> Many thanks, >>>>>> Ali >>>>>> >>>>>> On 8/29/2018 2:24 AM, Smith, Barry F. wrote: >>>>>>> Ali, >>>>>>> >>>>>>> In the branch barry/feature-PCVPBJACOBI (see src/snes/examples/tutorials/ex5.c) I have implemented PCVPBJACOBI that is a point block Jacobi with variable size blocks. It has very little testing. >>>>>>> >>>>>>> Could you please try your code with it; you should see very very similar convergence history with this branch and the previous approach you used (the only numerical difference between the two approaches is that this one uses a dense LU factorization for each small block while the previous used a sparse factorization). This new one should also be slightly faster in the KSPSolve(). >>>>>>> >>>>>>> Thanks >>>>>>> >>>>>>> Barry >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>>>> On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: >>>>>>>> >>>>>>>> "Smith, Barry F." writes: >>>>>>>> >>>>>>>>> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c >>>>>>>> Note that this example is block Jacobi with O(1) sparse blocks per >>>>>>>> process, not variable-sized point-block Jacobi which I think is what Ali >>>>>>>> had in mind. >>>>>>>> >>>>>>>>> Please let us know if it works for you and if you have any questions or problems. >>>>>>>>> >>>>>>>>> Barry >>>>>>>>> >>>>>>>>> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >>>>>>>>> >>>>>>>>> Sorry for the runaround with so many emails. >>>>>>>>> >>>>>>>>> >>>>>>>>>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>>>>>>>>> >>>>>>>>>> Hi, >>>>>>>>>> >>>>>>>>>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>>>>>>>>> >>>>>>>>>> Below is a part of my code. It is run serially. Any help is much appreciated. >>>>>>>>>> >>>>>>>>>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = SNESSetType(snes, SNESNEWTONLS); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> >>>>>>>>>> SNESSetUp(snes); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> >>>>>>>>>> for (i = 0; i < nLocal; i++) { >>>>>>>>>> ierr = KSPGetPC(subKSP[i], &SubPc); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = PCSetType(SubPc, PCLU); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> } >>>>>>>>>> ierr = SNESSolve(snes, NULL, Petsc_X); >>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>> >>>>>>>>>> >>>>>>>>>> >> -- >> Ali Reza Khaz?ali >> Assistant Professor of Petroleum Engineering, >> Department of Chemical Engineering >> Isfahan University of Technology >> Isfahan, Iran -- Ali Reza Khaz?ali Assistant Professor of Petroleum Engineering, Department of Chemical Engineering Isfahan University of Technology Isfahan, Iran From bsmith at mcs.anl.gov Wed Aug 29 14:15:04 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 29 Aug 2018 19:15:04 +0000 Subject: [petsc-users] C++ Makefile for PETSc program In-Reply-To: References: Message-ID: <29B97808-FA53-4E2B-B9CA-C33305165996@anl.gov> > On Aug 29, 2018, at 11:09 AM, Justin Dong wrote: > > Hi all, > > I have a program with C++ that I am trying to integrate with PETSc on MacOS X. My Makefile looks like this > > #-----[Makefile]------ > include ${PETSC_DIR}/lib/petsc/conf/variables > include ${PETSC_DIR}/lib/petsc/conf/rules > include ${PETSC_DIR}/lib/petsc/conf/test 1) Unless you are using a ./configure with a --prefix install option you need > include ${PETSC_DIR}/${PETSC_ARCH}/lib/petsc/conf/variables > include ${PETSC_DIR}/${PETSC_ARCH}/lib/petsc/conf/rules > include ${PETSC_DIR}/${PETSC_ARCH}/lib/petsc/conf/test 2) Though you include these files your makefile below IGNORES the various compiler flags that are set in these files hence, for example, the -I${PETSC_DIR}/include that tells the compiler the location of the PETSc makefile is not used. You need to at a minimum add to your compilerFlags variable the various variables set in the included files such as CFLAGS Barry > > #----[Directories]---- > oPath = obj > sPath = src > iPath = inc $(PETSC_LIB) > #==================== > > #---[Compiler and Settings]----- > compiler = g++-8 > compilerFlags = -std=c++11 -Wall -lm -llapack -lblas -O3 > paths = -I./$(iPath) > #====================== > > #----[Variable Names]------- > headers = $(wildcard $(iPath)/*.hpp) > sources = $(wildcard $(sPath)/*.cpp) > objects = $(subst $(sPath)/,$(oPath)/,$(sources:.cpp=.o)) > #========================== > > #----[Compilation]--------- > main:$(objects) $(headers) main.cpp > $(compiler) $(compilerFlags) -o main $(objects) main.cpp $(PETSC_LIB) $(paths) > $(oPath)/%.o:$(sPath)/%.cpp $(subst $(sPath)/, $(iPath)/,$(<:.cpp=.hpp)) > @mkdir -p $(@D) > $(compiler) $(compilerFlags) -o $@ -c $(paths) $< > > #-----[Clean up]------- > # clean:rm main > # rm -rf $(oPath)/ > > When I try to include "petsc.h", I get a "no such file or directory" error. I have PETSC_DIR and PETSC_ARCH set correctly, but I'm not the most proficient with Make. Can someone provide some tips on how to get this working properly? > > Best, > Justin From jed at jedbrown.org Wed Aug 29 14:20:38 2018 From: jed at jedbrown.org (Jed Brown) Date: Wed, 29 Aug 2018 13:20:38 -0600 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> <7b093784-8da8-1b00-9f31-a327d86882ab@cc.iut.ac.ir> <87in3t5a0j.fsf@jedbrown.org> <82f16e58-ab8e-2ab8-eb6b-26b9bd8e820e@cc.iut.ac.ir> <87a7p558ce.fsf@jedbrown.org> Message-ID: <874lfd569l.fsf@jedbrown.org> Ali Reza Khaz'ali writes: >> It looks like you have forgotten to destroy all of your objects. If you >> clean up after yourself, you'll also see the totaly memory used by each >> of the PETSc classes that you use. > > That is because of PetscLogView was placed before the destroy functions. > I moved it after them, and here is the new log: (additionally, this is > the log of one time step only, so all of the objects won't be destroyed > before all time steps have been finished) You can just use the run-time option and let PetscFinalize handle this output. > Memory usage is given in bytes: > > Object Type????????? Creations?? Destructions???? Memory Descendants' Mem. > Reports information only for process 0. > > --- Event Stage 0: Main Stage > > ??????????????? SNES???? 1????????????? 1???????? 1372???? 0. > ????????????? DMSNES???? 1????????????? 1????????? 672???? 0. > ????? SNESLineSearch???? 1????????????? 1???????? 1000???? 0. > ????????????? Vector??? 20???????????? 20???? 17313120???? 0. > ????????????? Matrix???? 1????????????? 1??? 105843212???? 0. As estimated previously, PETSc uses a little over 100 MB in total. > ??? Distributed Mesh???? 2????????????? 2???????? 9504???? 0. > ?? Star Forest Graph???? 4????????????? 4???????? 3200???? 0. > ???? Discrete System???? 2????????????? 2???????? 1856???? 0. > ?????? Krylov Solver???? 1????????????? 1??????? 18416???? 0. > ???? DMKSP interface???? 1????????????? 1????????? 656???? 0. > ????? Preconditioner???? 1????????????? 1????????? 832???? 0. > ????????????? Viewer???? 1????????????? 0??????????? 0???? 0. From mvalera-w at sdsu.edu Wed Aug 29 15:15:30 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 29 Aug 2018 13:15:30 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> Message-ID: By the way, one more piece of the puzzle that i feel may contribute, If i try setting the Preconditioner in the program as either one of: call PCSetType(pc,PCSAVIENNACL ,ierr) call PCSetType(pc,PCROWSCALINGVIENNACL,ierr) call PCSetType(pc,PCCHOWILUVIENNACL,ierr) It will give an error at compile time of the like: call PCSetType(pc,PCCHOWILUVIENNACL,ierr) 1 Error: Symbol 'pcchowiluviennacl' at (1) has no IMPLICIT type If i instead use: call PetscOptionsSetValue(PETSC_NULL_OPTIONS,'-pc_type','saviennacl',ierr) Or give it that option at execute time as a command line argument, it setups the matrix as intended and it works for one processor, Let me know if this rings a bell, i just tried updating the petsc repo and reinstalling but it didn't work, Thanks, Manuel On Wed, Aug 29, 2018 at 11:50 AM, Manuel Valera wrote: > Hi everyone, > > Thanks for your responses, i understand communicating on this way to this > level of technicality can be hard, i still think we can work ways to solve > this problem though, > > I can say the following at this point: > > > - Program works without issues in any other non-gpu preconditioner, > just by calling -pc_type ### . > - Program works correctly with ViennaCL preconditioners with mpirun -n > 1, that is on one processor. > - Program breaks with every ViennaCL preconditioner when attempting > any more than 1 processors. > - I haven't tried other GPU preconditioners because ViennaCL gave the > best performance in 1 processor before. > - I have made sure the matrix type is mpiaijviennacl as it is printed > right before the error log. > - I am attaching what i think are the backtrace logs of the run with > two cores, as i have limited experience with this kind of debugging, and i > cannot make sense of what they say, please let me know if you need me to do > something else. > > > Current options i can think of are giving you permission to clone my model > repo, or for you to guide me trough the process remotely, > > Thanks, > > .-.-.-.- > > > The error i get is still: > > Matrix type: mpiaijviennacl > > Of sizes: 125 x 125 > Matrix type: mpiaijviennacl > > Of sizes: 125 x 125 > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Currently only handles ViennaCL matrices > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 29 11:43:25 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ > interface/precon.c > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ > ksp/interface/itfunc.c > [1]PETSC ERROR: ------------------------------ > ------------------------------------------ > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > probably memory access out of range > [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] PetscTraceBackErrorHandler line 182 > /home/valera/petsc/src/sys/error/errtrace.c > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/ > error/err.c > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 29 11:43:25 2018 > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > -------------------------------------------------------------------------- > MPI_ABORT was invoked on rank 1 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. > -------------------------------------------------------------------------- > [0]PETSC ERROR: ------------------------------ > ------------------------------------------ > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the > batch system) has told this process to end > [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. > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 > /home/valera/petsc/src/mat/utils/gcreate.c > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ > ksp/interface/itfunc.c > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: Signal received > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 29 11:43:25 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file > [node50:32783] 1 more process has sent help message help-mpi-api.txt / > mpi-abort > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to see > all help / error messages > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp wrote: > >> Hi Manuel, >> >> as Barry said, it is hard for us to provide any help without having a >> more complete picture of what is going on. >> >> The error you report seems to come from the AMG preconditioner in >> ViennaCL. This can have many origins. Do other preconditioners run without >> error? Can you run in a debugger and provide a complete backtrace? >> >> Thanks and best regards, >> Karli >> >> >> On 08/29/2018 01:33 AM, Manuel Valera wrote: >> >>> Talked too fast, >>> >>> After fixing that problem, i tried more than one mpi processor and got >>> the following: >>> >>> Matrix type: mpiaijviennacl >>> Of sizes: 125 x 125 >>> Matrix type: mpiaijviennacl >>> Of sizes: 125 x 125 >>> [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> [0]PETSC ERROR: No support for this operation for this object type >>> [0]PETSC ERROR: Currently only handles ViennaCL matrices >>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >>> for trouble shooting. >>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT >>> Date: 2018-05-31 17:31:13 +0300 >>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue >>> Aug 28 16:30:02 2018 >>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>> --download-viennacl >>> [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >>> http://saviennacl.cu> >>> [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ >>> interface/precon.c >>> [1]PETSC ERROR: ------------------------------ >>> ------------------------------------------ >>> [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, >>> probably memory access out of range >>> [1]PETSC ERROR: Try option -start_in_debugger or >>> -on_error_attach_debugger >>> [1]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >>> ocumentation/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] PetscTraceBackErrorHandler line 182 >>> /home/valera/petsc/src/sys/error/errtrace.c >>> [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/err >>> or/err.c >>> [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >>> http://saviennacl.cu> >>> >>> [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >>> interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 GIT >>> Date: 2018-05-31 17:31:13 +0300 >>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue >>> Aug 28 16:30:02 2018 >>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>> --download-viennacl >>> [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >>> ------------------------------------------------------------ >>> -------------- >>> MPI_ABORT was invoked on rank 1 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. >>> ------------------------------------------------------------ >>> -------------- >>> [0]PETSC ERROR: ------------------------------ >>> ------------------------------------------ >>> [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the >>> batch system) has told this process to end >>> [0]PETSC ERROR: Try option -start_in_debugger or >>> -on_error_attach_debugger >>> [0]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >>> ocumentation/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. >>> [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>> /home/valera/petsc/src/sys/objects/tagm.c >>> [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >>> /home/valera/petsc/src/sys/objects/inherit.c >>> [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/ >>> is/interface/isreg.c >>> [0]PETSC ERROR: [0] ISCreateGeneral line 668 >>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>> [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >>> http://saviennacl.cu> >>> [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >>> interface/precon.c >>> [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> [0]PETSC ERROR: Signal received >>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >>> for trouble shooting. >>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT >>> Date: 2018-05-31 17:31:13 +0300 >>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue >>> Aug 28 16:30:02 2018 >>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>> --download-viennacl >>> [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >>> [node50:30582] 1 more process has sent help message help-mpi-api.txt / >>> mpi-abort >>> [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to see >>> all help / error messages >>> >>> >>> >>> It is currently running in 1 mpi processor + GPU but i would like to >>> call at least 16 mpi processors + GPU to do the rest of the data management >>> who is not part of the main laplacian on the mpi and the laplacian solution >>> on the GPU, is this currently possible? >>> >>> Thanks for your help, >>> >>> >>> >>> On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera >> > wrote: >>> >>> Ok, i found the culprit and we can close this thread, >>> >>> The problem was a missing variable for setting the maximum columns, >>> which i deleted at some point without realizing. The error message >>> was too ambiguous to catch this so i had to compare with a previous >>> working version of the arguments of MatSetValues, it was evident >>> then. >>> >>> Good news is that i can now set the values with the viennacl types >>> too, >>> >>> Thanks for your kind help, >>> >>> Manuel >>> >>> On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >>> > wrote: >>> >>> >>> 1) PetscMalloc() is never valid or needed in Fortran >>> >>> 2) there is no reason to use DMSetMatrixPreallocateOnly() >>> just use DMCreateMatrix() assuming that using a DM (DMDA, >>> DMPLEX, etc) is suitable for your problem. >>> >>> At this end we are totally guessing at what you are doing >>> and so have little help we can provide. A simple, nonworking >>> code that tries to do what you would need would help us a great >>> deal in understanding that you are trying to do. >>> >>> Barry >>> >>> >>> >>> >>> >>> > On Aug 28, 2018, at 1:18 PM, Manuel Valera >>> > wrote: >>> > >>> > Matthew, PetscMalloc gives the same error, >>> > >>> > Barry, it would be very hard for me to get the code to a >>> minimum working example, i guess all i need to understand is how >>> to setup a DM matrix with DMSetMatrixPreallocateOnly() instead >>> of MatMPIAIJSetPreallocation() as we were doing before, is there >>> a simple example who does this in Fortran? >>> > >>> > Is the PetscMalloc call needed? is 'call >>> PetscMalloc(1,row,ierr)' a valid, compilable call to >>> PetscMalloc? what other reason may there be for this error to >>> happen ? >>> > >>> > Just remembering, that trying to setup the matrix with the >>> MatAIJSetPreallocation() brings up an error to acknowledge the >>> viennacl datatypes and that's why i'm trying to make this change >>> on your recommendation, >>> > >>> > Thanks for your help, >>> > >>> > >>> > >>> > >>> > >>> > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >>> > wrote: >>> > >>> > Send your code in a way we can compile and run it; it must >>> be some simple issue that is hard to communicate in email. >>> > >>> > Barry >>> > >>> > >>> > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >>> > wrote: >>> > > >>> > > Hello everyone, >>> > > >>> > > I just had time to work on this again, and checked the code >>> for errors on the matrix entries, this is the exact code i was >>> using for creating the matrix without >>> DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and >>> it worked that way, but trying this way i get the same 'Column >>> too large' error using any number at the column position of >>> MatSetValues, >>> > > >>> > > I have set up my code to print the column argument (n) of >>> MatSetValues and in this case is 7 (lower than 124), it still >>> gives error, even entering a specific number in the MatSetValues >>> column argument position gives the same error. >>> > > >>> > > So next i went back to ex.50 here: >>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/t >>> utorials/ex50.c.html >>> >> tutorials/ex50.c.html> >>> and it has a very similar structure except the PetscMalloc1() >>> call, so i tried adding that and got: >>> > > >>> > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined >>> reference to `petscmalloc1_' >>> > > >>> > > Any ideas on this behaviour? >>> > > >>> > > Thanks so much, >>> > > >>> > > >>> > > >>> > > >>> > > >>> > > >>> > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >>> > wrote: >>> > > >>> > > Column too large: col 10980 max 124 >>> > > >>> > > You need to check the code that is generating the matrix >>> entries. The matrix has 124 columns but you are attempting to >>> put a value at column 10980 >>> > > >>> > > Barry >>> > > >>> > > >>> > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >>> > wrote: >>> > > > >>> > > > Thanks Matthew and Barry, >>> > > > >>> > > > Now my code looks like: >>> > > > >>> > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>> > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>> > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>> > > > call DMCreateMatrix(daDummy,A,ierr) >>> > > > call MatSetFromOptions(A,ierr) >>> > > > call MatSetUp(A,ierr) >>> > > > [...] >>> > > > call >>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INS >>> ERT_VALUES,ierr) >>> > > > [...] >>> > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >>> > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >>> > > > >>> > > > And i get a different error, now is: >>> > > > >>> > > > [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> > > > [0]PETSC ERROR: Argument out of range >>> > > > [0]PETSC ERROR: Column too large: col 10980 max 124 >>> > > > [0]PETSC ERROR: See >>> http://www.mcs.anl.gov/petsc/documentation/faq.html >>> for >>> trouble shooting. >>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 >>> by valera Wed Aug 15 19:40:00 2018 >>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>> --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in >>> /home/valera/petsc/src/mat/impls/aij/seq/aij.c >>> > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >>> /home/valera/petsc/src/mat/interface/matrix.c >>> > > > >>> > > > >>> > > > Thanks again, >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. >>> > wrote: >>> > > > >>> > > > Should be >>> > > > >>> > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>> > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>> > > > call DMCreateMatrix(daDummy,A,ierr) >>> > > > >>> > > > and remove the rest. You need to set the type of Mat >>> you want the DM to return BEFORE you create the matrix. >>> > > > >>> > > > Barry >>> > > > >>> > > > >>> > > > >>> > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >>> > wrote: >>> > > > > >>> > > > > Ok thanks for clarifying that, i wasn't sure if there >>> were different types, >>> > > > > >>> > > > > Here is a stripped down version of my code, it seems >>> like the preallocation is working now since the matrix >>> population part is working without problem, but here it is for >>> illustration purposes: >>> > > > > >>> > > > > call DMSetMatrixPreallocateOnly(daD >>> ummy,PETSC_TRUE,ierr) >>> > > > > call DMCreateMatrix(daDummy,A,ierr) >>> > > > > call MatSetFromOptions(A,ierr) >>> > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>> > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>> > > > > call >>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_N >>> ULL_INTEGER,ierr) >>> > > > > call MatSetUp(A,ierr) >>> > > > > [...] >>> > > > > call >>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INS >>> ERT_VALUES,ierr) >>> > > > > [...] >>> > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >>> > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >>> > > > > >>> > > > > Adding the first line there did the trick, >>> > > > > >>> > > > > Now the problem seems to be the program is not >>> recognizing the matrix as ViennaCL type when i try with more >>> than one processor, i get now: >>> > > > > >>> > > > > [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> > > > > [0]PETSC ERROR: No support for this operation for this >>> object type >>> > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>> > > > > [0]PETSC ERROR: See >>> http://www.mcs.anl.gov/petsc/documentation/faq.html >>> for >>> trouble shooting. >>> > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >>> node50 by valera Wed Aug 15 14:44:22 2018 >>> > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>> --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>> >>> > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>> > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>> > > > > >>> > > > > When running with: >>> > > > > >>> > > > > mpirun -n 1 ./gcmLEP.GPU >>> tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >>> -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl >>> -pc_type saviennacl -log_view >>> > > > > >>> > > > > >>> > > > > Thanks, >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley >>> > wrote: >>> > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >>> > wrote: >>> > > > > It seems to be resumed on: I do not know how to >>> preallocate a DM Matrix correctly. >>> > > > > >>> > > > > There is only one matrix type, Mat. There are no >>> separate DM matrices. A DM can create a matrix for you >>> > > > > using DMCreateMatrix(), but that is a Mat and it is >>> preallocated correctly. I am not sure what you are doing. >>> > > > > >>> > > > > Thanks, >>> > > > > >>> > > > > Matt >>> > > > > >>> > > > > The interesting part is that it only breaks when i need >>> to populate a GPU matrix from MPI, so kudos on that, but it >>> seems i need to do better on my code to get this setup working, >>> > > > > >>> > > > > Any help would be appreciated, >>> > > > > >>> > > > > Thanks, >>> > > > > >>> > > > > >>> > > > > >>> > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >>> > wrote: >>> > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >>> > wrote: >>> > > > > Thanks Matthew, >>> > > > > >>> > > > > I try to do that when calling: >>> > > > > >>> > > > > call >>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_N >>> ULL_INTEGER,ierr) >>> > > > > >>> > > > > But i am not aware on how to do this for the DM if it >>> needs something more specific/different, >>> > > > > >>> > > > > The error says that your preallocation is wrong for the >>> values you are putting in. The DM does not control either, >>> > > > > so I do not understand your email. >>> > > > > >>> > > > > Thanks, >>> > > > > >>> > > > > Matt >>> > > > > >>> > > > > Thanks, >>> > > > > >>> > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >>> > wrote: >>> > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>> > wrote: >>> > > > > Hello PETSc devs, >>> > > > > >>> > > > > I am running into an error when trying to use the >>> MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs >>> for MATSEQAIJVIENNACL type in one processor. The error happens >>> when calling MatSetValues for this specific configuration. It >>> does not occur when using MPI DMMatrix types only. >>> > > > > >>> > > > > The DM properly preallocates the matrix. I am assuming >>> you do not here. >>> > > > > >>> > > > > Matt >>> > > > > >>> > > > > Any help will be appreciated, >>> > > > > >>> > > > > Thanks, >>> > > > > >>> > > > > >>> > > > > >>> > > > > My program call: >>> > > > > >>> > > > > mpirun -n 2 ./gcmLEP.GPU >>> tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >>> -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl >>> -pc_type saviennacl -log_view >>> > > > > >>> > > > > >>> > > > > The error (repeats after each MatSetValues call): >>> > > > > >>> > > > > [1]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> > > > > [1]PETSC ERROR: Argument out of range >>> > > > > [1]PETSC ERROR: Inserting a new nonzero at global >>> row/column (75, 50) into matrix >>> > > > > [1]PETSC ERROR: See >>> http://www.mcs.anl.gov/petsc/documentation/faq.html >>> for >>> trouble shooting. >>> > > > > [1]PETSC ERROR: Petsc Development GIT revision: >>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >>> node50 by valera Wed Aug 15 13:10:44 2018 >>> > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>> --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >>> /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>> > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>> /home/valera/petsc/src/mat/interface/matrix.c >>> > > > > >>> > > > > >>> > > > > My Code structure: >>> > > > > >>> > > > > call DMCreateMatrix(daDummy,A,ierr) >>> > > > > call MatSetFromOptions(A,ierr) >>> > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >>> > > > > if (numprocs > 1) then ! set matrix type parallel >>> > > > > ! Get local size >>> > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>> > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) >>> > > > > call VecDestroy(Tmpnat,ierr) >>> > > > > ! Set matrix >>> > > > > #ifdef GPU >>> > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >>> > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>> > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>> > > > > print*,'SETTING GPU TYPES' >>> > > > > #else >>> > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>> > > > > call DMSetMatType(daDummy,VECMPI,ierr) >>> > > > > call MatSetType(A,MATMPIAIJ,ierr)! >>> > > > > #endif >>> > > > > call >>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_N >>> ULL_INTEGER,ierr) >>> > > > > else ! set matrix type sequential >>> > > > > #ifdef GPU >>> > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>> > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>> > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>> > > > > print*,'SETTING GPU TYPES' >>> > > > > #else >>> > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>> > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >>> > > > > call MatSetType(A,MATSEQAIJ,ierr) >>> > > > > #endif >>> > > > > call MatSetUp(A,ierr) >>> > > > > call >>> getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>> > > > > >>> > > > > do k=zstart,zend-1 >>> > > > > do j=ystart,yend-1 >>> > > > > do i=xstart,xend-1 >>> > > > > [..] >>> > > > > call >>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INS >>> ERT_VALUES,ierr) >>> > > > > [..] >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > -- >>> > > > > 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 >>> > > > > >>> > > > > https://www.cse.buffalo.edu/~knepley/ >>> >>> > > > > >>> > > > > >>> > > > > >>> > > > > -- >>> > > > > 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 >>> > > > > >>> > > > > https://www.cse.buffalo.edu/~knepley/ >>> >>> > > > > >>> > > > > >>> > > > > >>> > > > > -- >>> > > > > 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 >>> > > > > >>> > > > > https://www.cse.buffalo.edu/~knepley/ >>> >>> > > > > >>> > > > >>> > > > >>> > > >>> > > >>> > >>> > >>> >>> >>> >>> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 29 15:18:15 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 29 Aug 2018 20:18:15 +0000 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> <7b093784-8da8-1b00-9f31-a327d86882ab@cc.iut.ac.ir> <87in3t5a0j.fsf@jedbrown.org> <82f16e58-ab8e-2ab8-eb6b-26b9bd8e820e@cc.iut.ac.ir> <87a7p558ce.fsf@jedbrown.org> Message-ID: > On Aug 29, 2018, at 2:08 PM, Ali Reza Khaz'ali wrote: > > Thanks again, > > >> You might want to use a memory profiler to see if you have important >> leaks. See comment below about destroying objects and PETSc memory >> logging. > That's a very good suggestion. I'll do it. > > > >> This matrix takes just a little over 100 MB (only about 35 MB of which >> is needed). If this code is using a lot more memory than that, you >> should use a memory profiler to find out where (e.g., some data >> structures in your code). > The memory usage was high for the previous (and wrong) one with bjacobi/ilu. My code with vpbjacobi preconditioner Can you confirm if your code ran successfully with vpbjacobi and if the convergence history was very similar to that achieved using bjacobi ? Thanks Barry > only requires 150K, which as you stated, most of it is not required by PETSc. > > > >> All of your time is in function and Jacobian evaluation. >> The entire linear solve is less than 50 milliseconds. > Thanks for your comment. You are right. The Jacobian construction involves about 40K lines of code, and a lot of phase equilibrium calculations, which are very time intensive. > > > >> It looks like you have forgotten to destroy all of your objects. If you >> clean up after yourself, you'll also see the totaly memory used by each >> of the PETSc classes that you use. > That is because of PetscLogView was placed before the destroy functions. I moved it after them, and here is the new log: (additionally, this is the log of one time step only, so all of the objects won't be destroyed before all time steps have been finished) > > > SNES Object: 1 MPI processes > type: newtonls > maximum iterations=2000, maximum function evaluations=2000 > tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 > total number of linear solver iterations=3 > total number of function evaluations=2 > norm schedule ALWAYS > SNESLineSearch Object: 1 MPI processes > type: bt > interpolation: cubic > alpha=1.000000e-04 > maxstep=1.000000e+08, minlambda=1.000000e-12 > tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 > maximum iterations=40 > KSP Object: 1 MPI processes > type: gmres > restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > happy breakdown tolerance 1e-30 > maximum iterations=5000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-06, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: 1 MPI processes > type: vpbjacobi > linear system matrix = precond matrix: > Mat Object: 1 MPI processes > type: seqaij > rows=108000, cols=108000 > total: nonzeros=2868000, allocated nonzeros=8640000 > total number of mallocs used during MatSetValues calls =0 > not using I-node routines > ************************************************************************************************************************ > *** WIDEN YOUR WINDOW TO 120 CHARACTERS. Use 'enscript -r -fCourier9' to print this document *** > ************************************************************************************************************************ > > ---------------------------------------------- PETSc Performance Summary: ---------------------------------------------- > > E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a named ALIREZA-PC with 1 processor, by AliReza Wed Aug 29 23:33:39 2018 > Using Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5 GIT Date: 2018-08-28 19:19:26 -0500 > > Max Max/Min Avg Total > Time (sec): 1.190e+02 1.000 1.190e+02 > Objects: 3.600e+01 1.000 3.600e+01 > Flop: 2.867e+07 1.000 2.867e+07 2.867e+07 > Flop/sec: 2.408e+05 1.000 2.408e+05 2.408e+05 > MPI Messages: 0.000e+00 0.000 0.000e+00 0.000e+00 > MPI Message Lengths: 0.000e+00 0.000 0.000e+00 0.000e+00 > MPI Reductions: 0.000e+00 0.000 > > Flop counting convention: 1 flop = 1 real number operation of type (multiply/divide/add/subtract) > e.g., VecAXPY() for real vectors of length N --> 2N flop > and VecAXPY() for complex vectors of length N --> 8N flop > > Summary of Stages: ----- Time ------ ----- Flop ------ --- Messages --- -- Message Lengths -- -- Reductions -- > Avg %Total Avg %Total Count %Total Avg %Total Count %Total > 0: Main Stage: 1.1905e+02 100.0% 2.8668e+07 100.0% 0.000e+00 0.0% 0.000e+00 0.0% 0.000e+00 0.0% > > ------------------------------------------------------------------------------------------------------------------------ > See the 'Profiling' chapter of the users' manual for details on interpreting output. > Phase summary info: > Count: number of times phase was executed > Time and Flop: Max - maximum over all processors > Ratio - ratio of maximum to minimum over all processors > Mess: number of messages sent > AvgLen: average message length (bytes) > Reduct: number of global reductions > Global: entire computation > Stage: stages of a computation. Set stages with PetscLogStagePush() and PetscLogStagePop(). > %T - percent time in this phase %F - percent flop in this phase > %M - percent messages in this phase %L - percent message lengths in this phase > %R - percent reductions in this phase > Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time over all processors) > ------------------------------------------------------------------------------------------------------------------------ > Event Count Time (sec) Flop --- Global --- --- Stage ---- Total > Max Ratio Max Ratio Max Ratio Mess AvgLen Reduct %T %F %M %L %R %T %F %M %L %R Mflop/s > ------------------------------------------------------------------------------------------------------------------------ > > --- Event Stage 0: Main Stage > > PetscBarrier 1 1.0 2.1382e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > BuildTwoSidedF 2 1.0 4.2337e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > SNESSolve 1 1.0 1.0010e+02 1.0 2.87e+07 1.0 0.0e+00 0.0e+00 0.0e+00 84100 0 0 0 84100 0 0 0 0 > SNESFunctionEval 2 1.0 5.2605e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 > SNESJacobianEval 1 1.0 9.4788e+01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 80 0 0 0 0 80 0 0 0 0 0 > SNESLineSearch 1 1.0 2.6283e+00 1.0 6.82e+06 1.0 0.0e+00 0.0e+00 0.0e+00 2 24 0 0 0 2 24 0 0 0 3 > VecDot 1 1.0 1.8261e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 0.0e+00 0 1 0 0 0 0 1 0 0 0 1183 > VecMDot 3 1.0 8.1381e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 0.0e+00 0 5 0 0 0 0 5 0 0 0 1592 > VecNorm 7 1.0 6.5849e-03 1.0 1.51e+06 1.0 0.0e+00 0.0e+00 0.0e+00 0 5 0 0 0 0 5 0 0 0 230 > VecScale 4 1.0 1.6208e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 0.0e+00 0 2 0 0 0 0 2 0 0 0 2665 > VecCopy 3 1.0 4.4561e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecSet 2 1.0 1.4369e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecAXPY 1 1.0 1.5823e-04 1.0 2.16e+05 1.0 0.0e+00 0.0e+00 0.0e+00 0 1 0 0 0 0 1 0 0 0 1365 > VecWAXPY 1 1.0 1.9501e-04 1.0 1.08e+05 1.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 554 > VecMAXPY 4 1.0 7.7190e-04 1.0 1.94e+06 1.0 0.0e+00 0.0e+00 0.0e+00 0 7 0 0 0 0 7 0 0 0 2518 > VecAssemblyBegin 2 1.0 7.9970e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecAssemblyEnd 2 1.0 1.2402e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecReduceArith 2 1.0 2.8567e-04 1.0 4.32e+05 1.0 0.0e+00 0.0e+00 0.0e+00 0 2 0 0 0 0 2 0 0 0 1512 > VecReduceComm 1 1.0 5.1318e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > VecNormalize 4 1.0 4.6357e-04 1.0 1.30e+06 1.0 0.0e+00 0.0e+00 0.0e+00 0 5 0 0 0 0 5 0 0 0 2796 > MatMult 4 1.0 1.6927e-02 1.0 2.25e+07 1.0 0.0e+00 0.0e+00 0.0e+00 0 79 0 0 0 0 79 0 0 0 1330 > MatAssemblyBegin 2 1.0 8.5529e-07 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatAssemblyEnd 2 1.0 2.4032e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatZeroEntries 1 1.0 2.8857e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > MatView 1 1.0 3.3998e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > KSPSetUp 1 1.0 1.2325e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > KSPSolve 1 1.0 3.7389e-02 1.0 2.16e+07 1.0 0.0e+00 0.0e+00 0.0e+00 0 75 0 0 0 0 75 0 0 0 579 > KSPGMRESOrthog 3 1.0 1.3552e-03 1.0 2.59e+06 1.0 0.0e+00 0.0e+00 0.0e+00 0 9 0 0 0 0 9 0 0 0 1913 > PCSetUp 1 1.0 1.4842e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > PCApply 4 1.0 3.1607e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 > ------------------------------------------------------------------------------------------------------------------------ > > Memory usage is given in bytes: > > Object Type Creations Destructions Memory Descendants' Mem. > Reports information only for process 0. > > --- Event Stage 0: Main Stage > > SNES 1 1 1372 0. > DMSNES 1 1 672 0. > SNESLineSearch 1 1 1000 0. > Vector 20 20 17313120 0. > Matrix 1 1 105843212 0. > Distributed Mesh 2 2 9504 0. > Star Forest Graph 4 4 3200 0. > Discrete System 2 2 1856 0. > Krylov Solver 1 1 18416 0. > DMKSP interface 1 1 656 0. > Preconditioner 1 1 832 0. > Viewer 1 0 0 0. > ======================================================================================================================== > Average time to get PetscTime(): 0. > #PETSc Option Table entries: > -ksp_atol 1e-6 > -ksp_rtol 1e-5 > -snes_rtol 1e-4 > -sub_ksp_type preonly > -sub_pc_factor_mat_solver_type mkl_pardiso > -sub_pc_type lu > #End of PETSc Option Table entries > Compiled without FORTRAN kernels > Compiled with full precision matrices (default) > sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 sizeof(PetscScalar) 8 sizeof(PetscInt) 4 > Configure options: --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl --with-hypre-incl > ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in > clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdrive/E/Program_Fi > les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int > el64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debugging=0 --with-blas > -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool > s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 -Qopenmp" > ----------------------------------------- > Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC > Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit > Using PETSc directory: /home/alireza/PetscGit > Using PETSc arch: > ----------------------------------------- > > Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl -O2 -MT -wd4996 -Qopenmp > Using Fortran compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp -fpp > ----------------------------------------- > > Using include paths: -I/home/alireza/PetscGit/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include -I/cygdrive/E/hypre-2.11.2/ > Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include > ----------------------------------------- > > Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl > Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort > Using libraries: -L/home/alireza/PetscGit/lib -L/home/alireza/PetscGit/lib -lpetsc /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib /cygdrive/E/Trilinos-master/Bins/lib > /ml.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and > _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib Gdi32.lib User32.lib > Advapi32.lib Kernel32.lib Ws2_32.lib > ----------------------------------------- > > > > Many thanks > Ali > > > > >> >>> ======================================================================================================================== >>> Average time to get PetscTime(): 8.55292e-08 >>> #PETSc Option Table entries: >>> -ksp_atol 1e-6 >>> -ksp_rtol 1e-5 >>> -snes_rtol 1e-4 >>> -sub_ksp_type preonly >>> -sub_pc_factor_mat_solver_type mkl_pardiso >>> -sub_pc_type lu >>> #End of PETSc Option Table entries >>> Compiled without FORTRAN kernels >>> Compiled with full precision matrices (default) >>> sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 >>> sizeof(PetscScalar) 8 sizeof(PetscInt) 4 >>> Configure options: --prefix=/home/alireza/PetscGit >>> --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl >>> --with-hypre-incl >>> ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include >>> --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >>> --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in >>> clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib >>> ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" >>> --with-mpi-include=/cygdrive/E/Program_Fi >>> les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >>> --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int >>> el64/lib/impi.lib >>> --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe >>> --with-debugging=0 --with-blas >>> -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool >>> s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" >>> -FFLAGS="-MT -O2 -Qopenmp" >>> ----------------------------------------- >>> Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC >>> Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit >>> Using PETSc directory: /home/alireza/PetscGit >>> Using PETSc arch: >>> ----------------------------------------- >>> >>> Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >>> -O2 -MT -wd4996 -Qopenmp >>> Using Fortran compiler: >>> /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp >>> -fpp >>> ----------------------------------------- >>> >>> Using include paths: -I/home/alireza/PetscGit/include >>> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include >>> -I/cygdrive/E/hypre-2.11.2/ >>> Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include >>> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >>> ----------------------------------------- >>> >>> Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >>> Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe >>> ifort >>> Using libraries: -L/home/alireza/PetscGit/lib >>> -L/home/alireza/PetscGit/lib -lpetsc >>> /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >>> /cygdrive/E/Trilinos-master/Bins/lib >>> /ml.lib >>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and >>> _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib >>> Gdi32.lib User32.lib >>> Advapi32.lib Kernel32.lib Ws2_32.lib >>> ----------------------------------------- >>> >>> >>> >>> >>> >>> On 8/29/2018 10:29 PM, Jed Brown wrote: >>>> This is bjacobi/lu, not vpbjacobi. >>>> >>>> How are you measuring memory usage? See a couple inline comments below. >>>> >>>> Ali Reza Khaz'ali writes: >>>> >>>>> I noticed that I forgot to include the log for 10x10x5 system. Here it is: >>>>> >>>>> >>>>> 1 MPI processes >>>>> type: newtonls >>>>> maximum iterations=2000, maximum function evaluations=2000 >>>>> tolerances: relative=0.0001, absolute=1e-05, solution=1e-05 >>>>> total number of linear solver iterations=1 >>>>> total number of function evaluations=2 >>>>> norm schedule ALWAYS >>>>> SNESLineSearch Object: 1 MPI processes >>>>> type: bt >>>>> interpolation: cubic >>>>> alpha=1.000000e-04 >>>>> maxstep=1.000000e+08, minlambda=1.000000e-12 >>>>> tolerances: relative=1.000000e-08, absolute=1.000000e-15, >>>>> lambda=1.000000e-08 >>>>> maximum iterations=40 >>>>> KSP Object: 1 MPI processes >>>>> type: gmres >>>>> restart=30, using Classical (unmodified) Gram-Schmidt >>>>> Orthogonalization with no iterative refinement >>>>> happy breakdown tolerance 1e-30 >>>>> maximum iterations=5000, initial guess is zero >>>>> tolerances: relative=1e-05, absolute=1e-06, divergence=10000. >>>>> left preconditioning >>>>> using PRECONDITIONED norm type for convergence test >>>>> PC Object: 1 MPI processes >>>>> type: bjacobi >>>>> number of blocks = 1 >>>>> Local solve is same for all blocks, in the following KSP and PC >>>>> objects: >>>>> KSP Object: (sub_) 1 MPI processes >>>>> type: preonly >>>>> maximum iterations=10000, initial guess is zero >>>>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. >>>>> left preconditioning >>>>> using NONE norm type for convergence test >>>>> PC Object: (sub_) 1 MPI processes >>>>> type: lu >>>>> out-of-place factorization >>>>> tolerance for zero pivot 2.22045e-14 >>>>> matrix ordering: nd >>>>> factor fill ratio given 0., needed 0. >>>>> Factored matrix follows: >>>>> Mat Object: 1 MPI processes >>>>> type: mkl_pardiso >>>>> rows=6000, cols=6000 >>>>> package used to perform factorization: mkl_pardiso >>>>> total: nonzeros=150000, allocated nonzeros=150000 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> MKL_PARDISO run parameters: >>>>> MKL_PARDISO phase: 33 >>>>> MKL_PARDISO iparm[1]: 1 >>>>> MKL_PARDISO iparm[2]: 2 >>>>> MKL_PARDISO iparm[3]: 2 >>>>> MKL_PARDISO iparm[4]: 0 >>>>> MKL_PARDISO iparm[5]: 0 >>>>> MKL_PARDISO iparm[6]: 0 >>>>> MKL_PARDISO iparm[7]: 0 >>>>> MKL_PARDISO iparm[8]: 0 >>>>> MKL_PARDISO iparm[9]: 0 >>>>> MKL_PARDISO iparm[10]: 13 >>>>> MKL_PARDISO iparm[11]: 1 >>>>> MKL_PARDISO iparm[12]: 0 >>>>> MKL_PARDISO iparm[13]: 1 >>>>> MKL_PARDISO iparm[14]: 0 >>>>> MKL_PARDISO iparm[15]: 11228 >>>>> MKL_PARDISO iparm[16]: 7563 >>>>> MKL_PARDISO iparm[17]: 37035 >>>>> MKL_PARDISO iparm[18]: 4204238 >>>>> MKL_PARDISO iparm[19]: 2659 >>>>> MKL_PARDISO iparm[20]: 0 >>>>> MKL_PARDISO iparm[21]: 0 >>>>> MKL_PARDISO iparm[22]: 0 >>>>> MKL_PARDISO iparm[23]: 0 >>>>> MKL_PARDISO iparm[24]: 0 >>>>> MKL_PARDISO iparm[25]: 0 >>>>> MKL_PARDISO iparm[26]: 0 >>>>> MKL_PARDISO iparm[27]: 0 >>>>> MKL_PARDISO iparm[28]: 0 >>>>> MKL_PARDISO iparm[29]: 0 >>>>> MKL_PARDISO iparm[30]: 0 >>>>> MKL_PARDISO iparm[31]: 0 >>>>> MKL_PARDISO iparm[32]: 0 >>>>> MKL_PARDISO iparm[33]: 0 >>>>> MKL_PARDISO iparm[34]: -1 >>>>> MKL_PARDISO iparm[35]: 1 >>>>> MKL_PARDISO iparm[36]: 0 >>>>> MKL_PARDISO iparm[37]: 0 >>>>> MKL_PARDISO iparm[38]: 0 >>>>> MKL_PARDISO iparm[39]: 0 >>>>> MKL_PARDISO iparm[40]: 0 >>>>> MKL_PARDISO iparm[41]: 0 >>>>> MKL_PARDISO iparm[42]: 0 >>>>> MKL_PARDISO iparm[43]: 0 >>>>> MKL_PARDISO iparm[44]: 0 >>>>> MKL_PARDISO iparm[45]: 0 >>>>> MKL_PARDISO iparm[46]: 0 >>>>> MKL_PARDISO iparm[47]: 0 >>>>> MKL_PARDISO iparm[48]: 0 >>>>> MKL_PARDISO iparm[49]: 0 >>>>> MKL_PARDISO iparm[50]: 0 >>>>> MKL_PARDISO iparm[51]: 0 >>>>> MKL_PARDISO iparm[52]: 0 >>>>> MKL_PARDISO iparm[53]: 0 >>>>> MKL_PARDISO iparm[54]: 0 >>>>> MKL_PARDISO iparm[55]: 0 >>>>> MKL_PARDISO iparm[56]: 0 >>>>> MKL_PARDISO iparm[57]: -1 >>>>> MKL_PARDISO iparm[58]: 0 >>>>> MKL_PARDISO iparm[59]: 0 >>>>> MKL_PARDISO iparm[60]: 0 >>>>> MKL_PARDISO iparm[61]: 11228 >>>>> MKL_PARDISO iparm[62]: 7868 >>>>> MKL_PARDISO iparm[63]: 3629 >>>>> MKL_PARDISO iparm[64]: 0 >>>>> MKL_PARDISO maxfct: 1 >>>>> MKL_PARDISO mnum: 1 >>>>> MKL_PARDISO mtype: 11 >>>>> MKL_PARDISO n: 6000 >>>>> MKL_PARDISO nrhs: 1 >>>>> MKL_PARDISO msglvl: 0 >>>>> linear system matrix = precond matrix: >>>>> Mat Object: 1 MPI processes >>>>> type: seqaij >>>>> rows=6000, cols=6000 >>>>> total: nonzeros=150000, allocated nonzeros=480000 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> not using I-node routines >>>>> linear system matrix = precond matrix: >>>>> Mat Object: 1 MPI processes >>>>> type: seqaij >>>>> rows=6000, cols=6000 >>>>> total: nonzeros=150000, allocated nonzeros=480000 >>>> Note that you preallocated more than necessary here. >>>> >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> not using I-node routines >>>>> ************************************************************************************************************************ >>>>> *** WIDEN YOUR WINDOW TO 120 CHARACTERS. Use 'enscript -r >>>>> -fCourier9' to print this document *** >>>>> ************************************************************************************************************************ >>>>> >>>>> ---------------------------------------------- PETSc Performance >>>>> Summary: ---------------------------------------------- >>>>> >>>>> E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe >>>>> on a named ALIREZA-PC with 1 processor, by AliReza Wed Aug 29 22:12:30 2018 >>>>> Using Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5 GIT Date: >>>>> 2018-08-28 19:19:26 -0500 >>>>> >>>>> Max Max/Min Avg Total >>>>> Time (sec): 3.373e+01 1.000 3.373e+01 >>>>> Objects: 3.300e+01 1.000 3.300e+01 >>>>> Flop: 7.500e+05 1.000 7.500e+05 7.500e+05 >>>>> Flop/sec: 2.224e+04 1.000 2.224e+04 2.224e+04 >>>>> MPI Messages: 0.000e+00 0.000 0.000e+00 0.000e+00 >>>>> MPI Message Lengths: 0.000e+00 0.000 0.000e+00 0.000e+00 >>>>> MPI Reductions: 0.000e+00 0.000 >>>>> >>>>> Flop counting convention: 1 flop = 1 real number operation of type >>>>> (multiply/divide/add/subtract) >>>>> e.g., VecAXPY() for real vectors of length >>>>> N --> 2N flop >>>>> and VecAXPY() for complex vectors of length >>>>> N --> 8N flop >>>>> >>>>> Summary of Stages: ----- Time ------ ----- Flop ------ --- Messages >>>>> --- -- Message Lengths -- -- Reductions -- >>>>> Avg %Total Avg %Total Count >>>>> %Total Avg %Total Count %Total >>>>> 0: Main Stage: 3.3730e+01 100.0% 7.5000e+05 100.0% 0.000e+00 >>>>> 0.0% 0.000e+00 0.0% 0.000e+00 0.0% >>>>> >>>>> ------------------------------------------------------------------------------------------------------------------------ >>>>> See the 'Profiling' chapter of the users' manual for details on >>>>> interpreting output. >>>>> Phase summary info: >>>>> Count: number of times phase was executed >>>>> Time and Flop: Max - maximum over all processors >>>>> Ratio - ratio of maximum to minimum over all processors >>>>> Mess: number of messages sent >>>>> AvgLen: average message length (bytes) >>>>> Reduct: number of global reductions >>>>> Global: entire computation >>>>> Stage: stages of a computation. Set stages with PetscLogStagePush() >>>>> and PetscLogStagePop(). >>>>> %T - percent time in this phase %F - percent flop in this >>>>> phase >>>>> %M - percent messages in this phase %L - percent message >>>>> lengths in this phase >>>>> %R - percent reductions in this phase >>>>> Total Mflop/s: 10e-6 * (sum of flop over all processors)/(max time >>>>> over all processors) >>>>> ------------------------------------------------------------------------------------------------------------------------ >>>>> Event Count Time (sec) >>>>> Flop --- Global --- --- Stage ---- Total >>>>> Max Ratio Max Ratio Max Ratio Mess AvgLen >>>>> Reduct %T %F %M %L %R %T %F %M %L %R Mflop/s >>>>> ------------------------------------------------------------------------------------------------------------------------ >>>>> >>>>> --- Event Stage 0: Main Stage >>>>> >>>>> BuildTwoSidedF 2 1.0 7.9003e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> SNESSolve 1 1.0 7.3396e+00 1.0 7.50e+05 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 22100 0 0 0 22100 0 0 0 0 >>>>> SNESFunctionEval 2 1.0 3.8894e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> SNESJacobianEval 1 1.0 5.1611e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 15 0 0 0 0 15 0 0 0 0 0 >>>> Most of the time here is spent in your code computing the Jacobian, not >>>> in the solver. >>>> >>>>> SNESLineSearch 1 1.0 1.7655e-02 1.0 3.60e+05 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 48 0 0 0 0 48 0 0 0 20 >>>>> VecDot 1 1.0 1.1546e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 2 0 0 0 0 2 0 0 0 1039 >>>>> VecMDot 1 1.0 2.3093e-05 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 2 0 0 0 0 2 0 0 0 520 >>>>> VecNorm 5 1.0 4.9769e-01 1.0 6.00e+04 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 1 8 0 0 0 1 8 0 0 0 0 >>>>> VecScale 2 1.0 9.3291e-03 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 2 0 0 0 0 2 0 0 0 1 >>>>> VecCopy 3 1.0 2.3093e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> VecSet 4 1.0 1.5395e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> VecAXPY 1 1.0 2.5734e-02 1.0 1.20e+04 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 2 0 0 0 0 2 0 0 0 0 >>>>> VecWAXPY 1 1.0 1.3257e-05 1.0 6.00e+03 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 1 0 0 0 0 1 0 0 0 453 >>>>> VecMAXPY 2 1.0 2.3521e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 3 0 0 0 0 3 0 0 0 1020 >>>>> VecAssemblyBegin 2 1.0 7.9040e-02 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> VecAssemblyEnd 2 1.0 1.7961e-05 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> VecReduceArith 2 1.0 9.8359e-06 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 3 0 0 0 0 3 0 0 0 2440 >>>>> VecReduceComm 1 1.0 4.7041e-06 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> VecNormalize 2 1.0 9.3552e-03 1.0 3.60e+04 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 5 0 0 0 0 5 0 0 0 4 >>>>> MatMult 2 1.0 4.4860e-04 1.0 5.88e+05 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 78 0 0 0 0 78 0 0 0 1311 >>>>> MatSolve 2 1.0 1.7876e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 >>>>> MatLUFactorSym 1 1.0 7.6157e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 2 0 0 0 0 2 0 0 0 0 0 >>>>> MatLUFactorNum 1 1.0 6.5977e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 2 0 0 0 0 2 0 0 0 0 0 >>>>> MatAssemblyBegin 2 1.0 0.0000e+00 0.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> MatAssemblyEnd 2 1.0 1.2962e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> MatGetRowIJ 1 1.0 1.1534e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> MatGetOrdering 1 1.0 5.1809e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> MatZeroEntries 1 1.0 1.1298e-03 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> MatView 3 1.0 3.8344e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 >>>>> KSPSetUp 2 1.0 3.2843e-04 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 0 0 0 0 0 0 0 0 0 0 >>>>> KSPSolve 1 1.0 1.6414e+00 1.0 3.78e+05 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 5 50 0 0 0 5 50 0 0 0 0 >>>>> KSPGMRESOrthog 1 1.0 5.9015e-05 1.0 2.40e+04 1.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 0 3 0 0 0 0 3 0 0 0 407 >>>>> PCSetUp 2 1.0 1.4267e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 >>>>> PCSetUpOnBlocks 1 1.0 1.4266e+00 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 4 0 0 0 0 4 0 0 0 0 0 >>>>> PCApply 2 1.0 1.7882e-01 1.0 0.00e+00 0.0 0.0e+00 0.0e+00 >>>>> 0.0e+00 1 0 0 0 0 1 0 0 0 0 0 >>>>> ------------------------------------------------------------------------------------------------------------------------ >>>>> >>>>> Memory usage is given in bytes: >>>>> >>>>> Object Type Creations Destructions Memory Descendants' Mem. >>>>> Reports information only for process 0. >>>>> >>>>> --- Event Stage 0: Main Stage >>>>> >>>>> SNES 1 0 0 0. >>>>> DMSNES 1 0 0 0. >>>>> SNESLineSearch 1 0 0 0. >>>>> Vector 12 0 0 0. >>>>> Matrix 2 0 0 0. >>>>> Distributed Mesh 2 0 0 0. >>>>> Index Set 2 0 0 0. >>>>> Star Forest Graph 4 0 0 0. >>>>> Discrete System 2 0 0 0. >>>>> Krylov Solver 2 0 0 0. >>>>> DMKSP interface 1 0 0 0. >>>>> Preconditioner 2 0 0 0. >>>>> Viewer 1 0 0 0. >>>>> ======================================================================================================================== >>>>> Average time to get PetscTime(): 4.27647e-08 >>>>> #PETSc Option Table entries: >>>>> -ksp_atol 1e-6 >>>>> -ksp_rtol 1e-5 >>>>> -snes_rtol 1e-4 >>>>> -sub_ksp_type preonly >>>>> -sub_pc_factor_mat_solver_type mkl_pardiso >>>>> -sub_pc_type lu >>>>> #End of PETSc Option Table entries >>>>> Compiled without FORTRAN kernels >>>>> Compiled with full precision matrices (default) >>>>> sizeof(short) 2 sizeof(int) 4 sizeof(long) 4 sizeof(void*) 8 >>>>> sizeof(PetscScalar) 8 sizeof(PetscInt) 4 >>>>> Configure options: --prefix=/home/alireza/PetscGit >>>>> --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl >>>>> --with-hypre-incl >>>>> ude=/cygdrive/E/hypre-2.11.2/Builds/Bins/include >>>>> --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >>>>> --with-ml-include=/cygdrive/E/Trilinos-master/Bins/in >>>>> clude --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib >>>>> ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" >>>>> --with-mpi-include=/cygdrive/E/Program_Fi >>>>> les_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >>>>> --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/int >>>>> el64/lib/impi.lib >>>>> --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe >>>>> --with-debugging=0 --with-blas >>>>> -lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>>>> --with-lapack-lib=/cygdrive/E/Program_Files_x86/IntelSWTool >>>>> s/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>>>> -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" >>>>> -FFLAGS="-MT -O2 -Qopenmp" >>>>> ----------------------------------------- >>>>> Libraries compiled on 2018-08-29 08:35:21 on AliReza-PC >>>>> Machine characteristics: CYGWIN_NT-6.1-2.10.0-0.325-5-3-x86_64-64bit >>>>> Using PETSc directory: /home/alireza/PetscGit >>>>> Using PETSc arch: >>>>> ----------------------------------------- >>>>> >>>>> Using C compiler: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >>>>> -O2 -MT -wd4996 -Qopenmp >>>>> Using Fortran compiler: >>>>> /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe ifort -MT -O2 -Qopenmp >>>>> -fpp >>>>> ----------------------------------------- >>>>> >>>>> Using include paths: -I/home/alireza/PetscGit/include >>>>> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/include >>>>> -I/cygdrive/E/hypre-2.11.2/ >>>>> Builds/Bins/include -I/cygdrive/E/Trilinos-master/Bins/include >>>>> -I/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include >>>>> ----------------------------------------- >>>>> >>>>> Using C linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe icl >>>>> Using Fortran linker: /home/alireza/PETSc/lib/petsc/bin/win32fe/win32fe >>>>> ifort >>>>> Using libraries: -L/home/alireza/PetscGit/lib >>>>> -L/home/alireza/PetscGit/lib -lpetsc >>>>> /cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib >>>>> /cygdrive/E/Trilinos-master/Bins/lib >>>>> /ml.lib >>>>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>>>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and >>>>> _libraries/windows/mkl/lib/intel64_win/mkl_rt.lib >>>>> /cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/lib/impi.lib >>>>> Gdi32.lib User32.lib >>>>> Advapi32.lib Kernel32.lib Ws2_32.lib >>>>> ----------------------------------------- >>>>> >>>>> >>>>> >>>>> On 8/29/2018 7:40 PM, Smith, Barry F. wrote: >>>>>> You need to add the line >>>>>> >>>>>> ierr = MatSetVariableBlockSizes(J,3,lens);CHKERRQ(ierr); >>>>>> >>>>>> with the number of blocks replacing 3 and the sizes of each block in lens >>>>>> >>>>>> Barry >>>>>> >>>>>> >>>>>>> On Aug 29, 2018, at 4:27 AM, Ali Reza Khaz'ali wrote: >>>>>>> >>>>>>> Barry, >>>>>>> >>>>>>> Thanks a lot for your efforts. Using PCVPBJACOBI causes SNESSolve to throw the following error (the code and the system being simulated is the same, just PCBJACOBI changed to PCVPBJACOBI): >>>>>>> >>>>>>> >>>>>>> [0]PETSC ERROR: --------------------- Error Message --------------------------------------- >>>>>>> ----------------------- >>>>>>> [0]PETSC ERROR: Nonconforming object sizes >>>>>>> [0]PETSC ERROR: Total blocksizes 0 doesn't match number matrix rows 108000 >>>>>>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. >>>>>>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1238-g434eb0c8b5 GIT Date: 2018-08-28 19:19:26 -0500 >>>>>>> [0]PETSC ERROR: E:\Documents\Visual Studio 2015\Projects\compsim\x64\Release\compsim.exe on a named ALIREZA-PC by AliReza Wed Aug 29 13:46:38 2018 >>>>>>> [0]PETSC ERROR: Configure options --prefix=/home/alireza/PetscGit --with-mkl_pardiso-dir=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl -- >>>>>>> with-hypre-include=/cygdrive/E/hypre-2.11.2/Builds/Bins/include --with-hypre-lib=/cygdrive/E/hypre-2.11.2/Builds/Bins/lib/HYPRE.lib --with-ml-include=/cygdrive/E/Trilinos >>>>>>> -master/Bins/include --with-ml-lib=/cygdrive/E/Trilinos-master/Bins/lib/ml.lib ???with-openmp --with-cc="win32fe icl" --with-fc="win32fe ifort" --with-mpi-include=/cygdri >>>>>>> ve/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/include --with-mpi-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/ >>>>>>> windows/mpi/intel64/lib/impi.lib --with-mpi-mpiexec=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mpi/intel64/bin/mpiexec.exe --with-debuggin >>>>>>> g=0 --with-blas-lib=/cygdrive/E/Program_Files_x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib --with-lapack-lib=/cygdrive/E/Program_Files_ >>>>>>> x86/IntelSWTools/compilers_and_libraries/windows/mkl/lib/intel64_win/mkl_rt.lib -CFLAGS="-O2 -MT -wd4996 -Qopenmp" -CXXFLAGS="-O2 -MT -wd4996 -Qopenmp" -FFLAGS="-MT -O2 - >>>>>>> Qopenmp" >>>>>>> [0]PETSC ERROR: #1 MatInvertVariableBlockDiagonal_SeqAIJ() line 1569 in E:\cygwin64\home\alireza\PETSc\src\mat\impls\aij\seq\aij.c >>>>>>> [0]PETSC ERROR: #2 MatInvertVariableBlockDiagonal() line 10482 in E:\cygwin64\home\alireza\PETSc\src\mat\interface\matrix.c >>>>>>> [0]PETSC ERROR: #3 PCSetUp_VPBJacobi() line 120 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\impls\vpbjacobi\vpbjacobi.c >>>>>>> [0]PETSC ERROR: #4 PCSetUp() line 932 in E:\cygwin64\home\alireza\PETSc\src\ksp\pc\interface\precon.c >>>>>>> [0]PETSC ERROR: #5 KSPSetUp() line 381 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >>>>>>> [0]PETSC ERROR: #6 KSPSolve() line 612 in E:\cygwin64\home\alireza\PETSc\src\ksp\ksp\interface\itfunc.c >>>>>>> [0]PETSC ERROR: #7 SNESSolve_NEWTONLS() line 224 in E:\cygwin64\home\alireza\PETSc\src\snes\impls\ls\ls.c >>>>>>> [0]PETSC ERROR: #8 SNESSolve() line 4355 in E:\cygwin64\home\alireza\PETSc\src\snes\interface\snes.c >>>>>>> >>>>>>> Many thanks, >>>>>>> Ali >>>>>>> >>>>>>> On 8/29/2018 2:24 AM, Smith, Barry F. wrote: >>>>>>>> Ali, >>>>>>>> >>>>>>>> In the branch barry/feature-PCVPBJACOBI (see src/snes/examples/tutorials/ex5.c) I have implemented PCVPBJACOBI that is a point block Jacobi with variable size blocks. It has very little testing. >>>>>>>> >>>>>>>> Could you please try your code with it; you should see very very similar convergence history with this branch and the previous approach you used (the only numerical difference between the two approaches is that this one uses a dense LU factorization for each small block while the previous used a sparse factorization). This new one should also be slightly faster in the KSPSolve(). >>>>>>>> >>>>>>>> Thanks >>>>>>>> >>>>>>>> Barry >>>>>>>> >>>>>>>> >>>>>>>> >>>>>>>> >>>>>>>>> On Aug 27, 2018, at 4:04 PM, Jed Brown wrote: >>>>>>>>> >>>>>>>>> "Smith, Barry F." writes: >>>>>>>>> >>>>>>>>>> I have added new functionality within SNES to allow one to do as you desire in the branch barry/feature-snessetkspsetupcallback. Please see src/snes/examples/tests/ex3.c >>>>>>>>> Note that this example is block Jacobi with O(1) sparse blocks per >>>>>>>>> process, not variable-sized point-block Jacobi which I think is what Ali >>>>>>>>> had in mind. >>>>>>>>> >>>>>>>>>> Please let us know if it works for you and if you have any questions or problems. >>>>>>>>>> >>>>>>>>>> Barry >>>>>>>>>> >>>>>>>>>> Note that it has to be handled by a callback called from within the SNES solver because that is the first time the matrix exists in a form that the block sizes may be set. >>>>>>>>>> >>>>>>>>>> Sorry for the runaround with so many emails. >>>>>>>>>> >>>>>>>>>> >>>>>>>>>>> On Aug 24, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: >>>>>>>>>>> >>>>>>>>>>> Hi, >>>>>>>>>>> >>>>>>>>>>> I am trying to use block Jacobi preconditioner in SNES (SNESNEWTONLS). However, PCBJacobiGetSubKSP function returns an error stating "Object is in wrong state, Must call KSPSetUp() or PCSetUp() first". When I add KSPSetUp, I got and error from them as: "Must call DMShellSetGlobalVector() or DMShellSetCreateGlobalVector()", and if PCSetUp is added, "Object is in wrong state, Matrix must be set first" error is printed. >>>>>>>>>>> >>>>>>>>>>> Below is a part of my code. It is run serially. Any help is much appreciated. >>>>>>>>>>> >>>>>>>>>>> ierr = SNESGetKSP(snes, &Petsc_ksp); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = KSPGetPC(Petsc_ksp, &Petsc_pc); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = KSPSetTolerances(Petsc_ksp, 1.e-3, 1e-3, PETSC_DEFAULT, 20000); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = SNESSetTolerances(snes, 1e-1, 1e-1, 1e-1, 2000, 2000); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = SNESSetType(snes, SNESNEWTONLS); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = KSPSetType(Petsc_ksp, KSPGMRES); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = PCSetType(Petsc_pc, PCBJACOBI); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = PCBJacobiSetTotalBlocks(Petsc_pc, 2*Nx*Ny*Nz, SadeqSize); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> >>>>>>>>>>> SNESSetUp(snes); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = PCBJacobiGetSubKSP(Petsc_pc, &nLocal, &Firstly, &subKSP); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> >>>>>>>>>>> for (i = 0; i < nLocal; i++) { >>>>>>>>>>> ierr = KSPGetPC(subKSP[i], &SubPc); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = PCSetType(SubPc, PCLU); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = PCFactorSetMatSolverPackage(SubPc, "mkl_pardiso"); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = KSPSetType(subKSP[i], KSPPREONLY); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> ierr = KSPSetTolerances(subKSP[i], 1.e-6, PETSC_DEFAULT, PETSC_DEFAULT, PETSC_DEFAULT); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> } >>>>>>>>>>> ierr = SNESSolve(snes, NULL, Petsc_X); >>>>>>>>>>> CHKERRQ(ierr); >>>>>>>>>>> >>>>>>>>>>> >>>>>>>>>>> >>> -- >>> Ali Reza Khaz?ali >>> Assistant Professor of Petroleum Engineering, >>> Department of Chemical Engineering >>> Isfahan University of Technology >>> Isfahan, Iran > > -- > Ali Reza Khaz?ali > Assistant Professor of Petroleum Engineering, > Department of Chemical Engineering > Isfahan University of Technology > Isfahan, Iran > From bsmith at mcs.anl.gov Wed Aug 29 15:22:16 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 29 Aug 2018 20:22:16 +0000 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> Message-ID: <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> The error message from the code is inaccurate: static PetscErrorCode PCSetUp_SAVIENNACL(PC pc) { PC_SAVIENNACL *sa = (PC_SAVIENNACL*)pc->data; PetscBool flg = PETSC_FALSE; PetscErrorCode ierr; Mat_SeqAIJViennaCL *gpustruct; PetscFunctionBegin; ierr = PetscObjectTypeCompare((PetscObject)pc->pmat,MATSEQAIJVIENNACL,&flg);CHKERRQ(ierr); if (!flg) SETERRQ(PetscObjectComm((PetscObject)pc),PETSC_ERR_SUP,"Currently only handles ViennaCL matrices"); It really should say currently only handles sequential ViennaCL matrices. So Karl will need to determine what parallel preconditioners are suitable for GPUs. You may need to use just plain PCBJACOBI or PCASM for parallelism and then SAVIENNACL sequentially on each block. Barry > On Aug 29, 2018, at 1:50 PM, Manuel Valera wrote: > > Hi everyone, > > Thanks for your responses, i understand communicating on this way to this level of technicality can be hard, i still think we can work ways to solve this problem though, > > I can say the following at this point: > > ? Program works without issues in any other non-gpu preconditioner, just by calling -pc_type ### . > ? Program works correctly with ViennaCL preconditioners with mpirun -n 1, that is on one processor. > ? Program breaks with every ViennaCL preconditioner when attempting any more than 1 processors. > ? I haven't tried other GPU preconditioners because ViennaCL gave the best performance in 1 processor before. > ? I have made sure the matrix type is mpiaijviennacl as it is printed right before the error log. > ? I am attaching what i think are the backtrace logs of the run with two cores, as i have limited experience with this kind of debugging, and i cannot make sense of what they say, please let me know if you need me to do something else. > > Current options i can think of are giving you permission to clone my model repo, or for you to guide me trough the process remotely, > > Thanks, > > .-.-.-.- > > > The error i get is still: > > Matrix type: mpiaijviennacl > Of sizes: 125 x 125 > Matrix type: mpiaijviennacl > Of sizes: 125 x 125 > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Currently only handles ViennaCL matrices > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > [1]PETSC ERROR: ------------------------------------------------------------------------ > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > -------------------------------------------------------------------------- > MPI_ABORT was invoked on rank 1 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. > -------------------------------------------------------------------------- > [0]PETSC ERROR: ------------------------------------------------------------------------ > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > [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. > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 /home/valera/petsc/src/mat/utils/gcreate.c > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Signal received > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file > [node50:32783] 1 more process has sent help message help-mpi-api.txt / mpi-abort > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp wrote: > Hi Manuel, > > as Barry said, it is hard for us to provide any help without having a more complete picture of what is going on. > > The error you report seems to come from the AMG preconditioner in ViennaCL. This can have many origins. Do other preconditioners run without error? Can you run in a debugger and provide a complete backtrace? > > Thanks and best regards, > Karli > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: > Talked too fast, > > After fixing that problem, i tried more than one mpi processor and got the following: > > Matrix type: mpiaijviennacl > Of sizes: 125 x 125 > Matrix type: mpiaijviennacl > Of sizes: 125 x 125 > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Currently only handles ViennaCL matrices > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > [1]PETSC ERROR: ------------------------------------------------------------------------ > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > -------------------------------------------------------------------------- > MPI_ABORT was invoked on rank 1 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. > -------------------------------------------------------------------------- > [0]PETSC ERROR: ------------------------------------------------------------------------ > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > [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. > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 /home/valera/petsc/src/sys/objects/tagm.c > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 /home/valera/petsc/src/sys/objects/inherit.c > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/is/interface/isreg.c > [0]PETSC ERROR: [0] ISCreateGeneral line 668 /home/valera/petsc/src/vec/is/is/impls/general/general.c > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Signal received > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > [node50:30582] 1 more process has sent help message help-mpi-api.txt / mpi-abort > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > It is currently running in 1 mpi processor + GPU but i would like to call at least 16 mpi processors + GPU to do the rest of the data management who is not part of the main laplacian on the mpi and the laplacian solution on the GPU, is this currently possible? > > Thanks for your help, > > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > wrote: > > Ok, i found the culprit and we can close this thread, > > The problem was a missing variable for setting the maximum columns, > which i deleted at some point without realizing. The error message > was too ambiguous to catch this so i had to compare with a previous > working version of the arguments of MatSetValues, it was evident then. > > Good news is that i can now set the values with the viennacl types too, > > Thanks for your kind help, > > Manuel > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. > > wrote: > > > 1) PetscMalloc() is never valid or needed in Fortran > > 2) there is no reason to use DMSetMatrixPreallocateOnly() > just use DMCreateMatrix() assuming that using a DM (DMDA, > DMPLEX, etc) is suitable for your problem. > > At this end we are totally guessing at what you are doing > and so have little help we can provide. A simple, nonworking > code that tries to do what you would need would help us a great > deal in understanding that you are trying to do. > > Barry > > > > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera > > wrote: > > > > Matthew, PetscMalloc gives the same error, > > > > Barry, it would be very hard for me to get the code to a > minimum working example, i guess all i need to understand is how > to setup a DM matrix with DMSetMatrixPreallocateOnly() instead > of MatMPIAIJSetPreallocation() as we were doing before, is there > a simple example who does this in Fortran? > > > > Is the PetscMalloc call needed? is 'call > PetscMalloc(1,row,ierr)' a valid, compilable call to > PetscMalloc? what other reason may there be for this error to > happen ? > > > > Just remembering, that trying to setup the matrix with the > MatAIJSetPreallocation() brings up an error to acknowledge the > viennacl datatypes and that's why i'm trying to make this change > on your recommendation, > > > > Thanks for your help, > > > > > > > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. > > wrote: > > > > Send your code in a way we can compile and run it; it must > be some simple issue that is hard to communicate in email. > > > > Barry > > > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera > > wrote: > > > > > > Hello everyone, > > > > > > I just had time to work on this again, and checked the code > for errors on the matrix entries, this is the exact code i was > using for creating the matrix without > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and > it worked that way, but trying this way i get the same 'Column > too large' error using any number at the column position of > MatSetValues, > > > > > > I have set up my code to print the column argument (n) of > MatSetValues and in this case is 7 (lower than 124), it still > gives error, even entering a specific number in the MatSetValues > column argument position gives the same error. > > > > > > So next i went back to ex.50 here: > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html > > and it has a very similar structure except the PetscMalloc1() > call, so i tried adding that and got: > > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined > reference to `petscmalloc1_' > > > > > > Any ideas on this behaviour? > > > > > > Thanks so much, > > > > > > > > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > > wrote: > > > > > > Column too large: col 10980 max 124 > > > > > > You need to check the code that is generating the matrix > entries. The matrix has 124 columns but you are attempting to > put a value at column 10980 > > > > > > Barry > > > > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera > > wrote: > > > > > > > > Thanks Matthew and Barry, > > > > > > > > Now my code looks like: > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > call MatSetFromOptions(A,ierr) > > > > call MatSetUp(A,ierr) > > > > [...] > > > > call > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > [...] > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > And i get a different error, now is: > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > [0]PETSC ERROR: Argument out of range > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > > [0]PETSC ERROR: See > http://www.mcs.anl.gov/petsc/documentation/faq.html > for > trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 > by valera Wed Aug 15 19:40:00 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > > wrote: > > > > > > > > Should be > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > and remove the rest. You need to set the type of Mat > you want the DM to return BEFORE you create the matrix. > > > > > > > > Barry > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera > > wrote: > > > > > > > > > > Ok thanks for clarifying that, i wasn't sure if there > were different types, > > > > > > > > > > Here is a stripped down version of my code, it seems > like the preallocation is working now since the matrix > population part is working without problem, but here it is for > illustration purposes: > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > call MatSetFromOptions(A,ierr) > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > call > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > call MatSetUp(A,ierr) > > > > > [...] > > > > > call > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > [...] > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > Adding the first line there did the trick, > > > > > > > > > > Now the problem seems to be the program is not > recognizing the matrix as ViennaCL type when i try with more > than one processor, i get now: > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > > [0]PETSC ERROR: No support for this operation for this > object type > > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > > [0]PETSC ERROR: See > http://www.mcs.anl.gov/petsc/documentation/faq.html > for > trouble shooting. > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > node50 by valera Wed Aug 15 14:44:22 2018 > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > > > When running with: > > > > > > > > > > mpirun -n 1 ./gcmLEP.GPU > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > > wrote: > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > > wrote: > > > > > It seems to be resumed on: I do not know how to > preallocate a DM Matrix correctly. > > > > > > > > > > There is only one matrix type, Mat. There are no > separate DM matrices. A DM can create a matrix for you > > > > > using DMCreateMatrix(), but that is a Mat and it is > preallocated correctly. I am not sure what you are doing. > > > > > > > > > > Thanks, > > > > > > > > > > Matt > > > > > > > > > > The interesting part is that it only breaks when i need > to populate a GPU matrix from MPI, so kudos on that, but it > seems i need to do better on my code to get this setup working, > > > > > > > > > > Any help would be appreciated, > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > > wrote: > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > > wrote: > > > > > Thanks Matthew, > > > > > > > > > > I try to do that when calling: > > > > > > > > > > call > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > > > But i am not aware on how to do this for the DM if it > needs something more specific/different, > > > > > > > > > > The error says that your preallocation is wrong for the > values you are putting in. The DM does not control either, > > > > > so I do not understand your email. > > > > > > > > > > Thanks, > > > > > > > > > > Matt > > > > > > > > > > Thanks, > > > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > > wrote: > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > > wrote: > > > > > Hello PETSc devs, > > > > > > > > > > I am running into an error when trying to use the > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs > for MATSEQAIJVIENNACL type in one processor. The error happens > when calling MatSetValues for this specific configuration. It > does not occur when using MPI DMMatrix types only. > > > > > > > > > > The DM properly preallocates the matrix. I am assuming > you do not here. > > > > > > > > > > Matt > > > > > > > > > > Any help will be appreciated, > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > My program call: > > > > > > > > > > mpirun -n 2 ./gcmLEP.GPU > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > > > [1]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > > [1]PETSC ERROR: Argument out of range > > > > > [1]PETSC ERROR: Inserting a new nonzero at global > row/column (75, 50) into matrix > > > > > [1]PETSC ERROR: See > http://www.mcs.anl.gov/petsc/documentation/faq.html > for > trouble shooting. > > > > > [1]PETSC ERROR: Petsc Development GIT revision: > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > node50 by valera Wed Aug 15 13:10:44 2018 > > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > My Code structure: > > > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > call MatSetFromOptions(A,ierr) > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > > > if (numprocs > 1) then ! set matrix type parallel > > > > > ! Get local size > > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > > call VecDestroy(Tmpnat,ierr) > > > > > ! Set matrix > > > > > #ifdef GPU > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > print*,'SETTING GPU TYPES' > > > > > #else > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > > > #endif > > > > > call > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > else ! set matrix type sequential > > > > > #ifdef GPU > > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > > print*,'SETTING GPU TYPES' > > > > > #else > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > > > call MatSetType(A,MATSEQAIJ,ierr) > > > > > #endif > > > > > call MatSetUp(A,ierr) > > > > > call > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > > > do k=zstart,zend-1 > > > > > do j=ystart,yend-1 > > > > > do i=xstart,xend-1 > > > > > [..] > > > > > call > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > 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 > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > -- > > > > > 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 > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > -- > > > > > 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 > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > From mvalera-w at sdsu.edu Wed Aug 29 15:26:39 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 29 Aug 2018 13:26:39 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> Message-ID: You may need to use just plain PCBJACOBI or PCASM for parallelism and then > SAVIENNACL sequentially on each block. > > Can you elaborate a little in how to do this? do you mean i can only use viennacl in serial at the moment or this is a suggestion of a workaround on how to make it work? Thanks, > > On Aug 29, 2018, at 1:50 PM, Manuel Valera wrote: > > > > Hi everyone, > > > > Thanks for your responses, i understand communicating on this way to > this level of technicality can be hard, i still think we can work ways to > solve this problem though, > > > > I can say the following at this point: > > > > ? Program works without issues in any other non-gpu > preconditioner, just by calling -pc_type ### . > > ? Program works correctly with ViennaCL preconditioners with > mpirun -n 1, that is on one processor. > > ? Program breaks with every ViennaCL preconditioner when > attempting any more than 1 processors. > > ? I haven't tried other GPU preconditioners because ViennaCL gave > the best performance in 1 processor before. > > ? I have made sure the matrix type is mpiaijviennacl as it is > printed right before the error log. > > ? I am attaching what i think are the backtrace logs of the run > with two cores, as i have limited experience with this kind of debugging, > and i cannot make sense of what they say, please let me know if you need me > to do something else. > > > > Current options i can think of are giving you permission to clone my > model repo, or for you to guide me trough the process remotely, > > > > Thanks, > > > > .-.-.-.- > > > > > > The error i get is still: > > > > Matrix type: mpiaijviennacl > > > Of sizes: 125 x 125 > > Matrix type: mpiaijviennacl > > > Of sizes: 125 x 125 > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [0]PETSC ERROR: No support for this operation for this object type > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 29 11:43:25 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ > ksp/interface/itfunc.c > > [1]PETSC ERROR: ------------------------------ > ------------------------------------------ > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > probably memory access out of range > > [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] PetscTraceBackErrorHandler line 182 > /home/valera/petsc/src/sys/error/errtrace.c > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/ > error/err.c > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 29 11:43:25 2018 > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > ------------------------------------------------------------ > -------------- > > MPI_ABORT was invoked on rank 1 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. > > ------------------------------------------------------------ > -------------- > > [0]PETSC ERROR: ------------------------------ > ------------------------------------------ > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the > batch system) has told this process to end > > [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. > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 > /home/valera/petsc/src/mat/utils/gcreate.c > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ > ksp/interface/itfunc.c > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [0]PETSC ERROR: Signal received > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 29 11:43:25 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file > > [node50:32783] 1 more process has sent help message help-mpi-api.txt / > mpi-abort > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to see > all help / error messages > > > > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp > wrote: > > Hi Manuel, > > > > as Barry said, it is hard for us to provide any help without having a > more complete picture of what is going on. > > > > The error you report seems to come from the AMG preconditioner in > ViennaCL. This can have many origins. Do other preconditioners run without > error? Can you run in a debugger and provide a complete backtrace? > > > > Thanks and best regards, > > Karli > > > > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: > > Talked too fast, > > > > After fixing that problem, i tried more than one mpi processor and got > the following: > > > > Matrix type: mpiaijviennacl > > Of sizes: 125 x 125 > > Matrix type: mpiaijviennacl > > Of sizes: 125 x 125 > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [0]PETSC ERROR: No support for this operation for this object type > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue > Aug 28 16:30:02 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < > http://saviennacl.cu> > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > [1]PETSC ERROR: ------------------------------ > ------------------------------------------ > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > probably memory access out of range > > [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] PetscTraceBackErrorHandler line 182 > /home/valera/petsc/src/sys/error/errtrace.c > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/ > error/err.c > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < > http://saviennacl.cu> > > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue > Aug 28 16:30:02 2018 > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > ------------------------------------------------------------ > -------------- > > MPI_ABORT was invoked on rank 1 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. > > ------------------------------------------------------------ > -------------- > > [0]PETSC ERROR: ------------------------------ > ------------------------------------------ > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the > batch system) has told this process to end > > [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. > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 > /home/valera/petsc/src/sys/objects/tagm.c > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 > /home/valera/petsc/src/sys/objects/inherit.c > > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/ > is/interface/isreg.c > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 > /home/valera/petsc/src/vec/is/is/impls/general/general.c > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < > http://saviennacl.cu> > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [0]PETSC ERROR: Signal received > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT > Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue > Aug 28 16:30:02 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > > [node50:30582] 1 more process has sent help message help-mpi-api.txt / > mpi-abort > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to see > all help / error messages > > > > > > > > It is currently running in 1 mpi processor + GPU but i would like to > call at least 16 mpi processors + GPU to do the rest of the data management > who is not part of the main laplacian on the mpi and the laplacian solution > on the GPU, is this currently possible? > > > > Thanks for your help, > > > > > > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > wrote: > > > > Ok, i found the culprit and we can close this thread, > > > > The problem was a missing variable for setting the maximum columns, > > which i deleted at some point without realizing. The error message > > was too ambiguous to catch this so i had to compare with a previous > > working version of the arguments of MatSetValues, it was evident > then. > > > > Good news is that i can now set the values with the viennacl types > too, > > > > Thanks for your kind help, > > > > Manuel > > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. > > > wrote: > > > > > > 1) PetscMalloc() is never valid or needed in Fortran > > > > 2) there is no reason to use DMSetMatrixPreallocateOnly() > > just use DMCreateMatrix() assuming that using a DM (DMDA, > > DMPLEX, etc) is suitable for your problem. > > > > At this end we are totally guessing at what you are doing > > and so have little help we can provide. A simple, nonworking > > code that tries to do what you would need would help us a great > > deal in understanding that you are trying to do. > > > > Barry > > > > > > > > > > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera > > > wrote: > > > > > > Matthew, PetscMalloc gives the same error, > > > > > > Barry, it would be very hard for me to get the code to a > > minimum working example, i guess all i need to understand is how > > to setup a DM matrix with DMSetMatrixPreallocateOnly() instead > > of MatMPIAIJSetPreallocation() as we were doing before, is there > > a simple example who does this in Fortran? > > > > > > Is the PetscMalloc call needed? is 'call > > PetscMalloc(1,row,ierr)' a valid, compilable call to > > PetscMalloc? what other reason may there be for this error to > > happen ? > > > > > > Just remembering, that trying to setup the matrix with the > > MatAIJSetPreallocation() brings up an error to acknowledge the > > viennacl datatypes and that's why i'm trying to make this change > > on your recommendation, > > > > > > Thanks for your help, > > > > > > > > > > > > > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. > > > wrote: > > > > > > Send your code in a way we can compile and run it; it must > > be some simple issue that is hard to communicate in email. > > > > > > Barry > > > > > > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera > > > wrote: > > > > > > > > Hello everyone, > > > > > > > > I just had time to work on this again, and checked the code > > for errors on the matrix entries, this is the exact code i was > > using for creating the matrix without > > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and > > it worked that way, but trying this way i get the same 'Column > > too large' error using any number at the column position of > > MatSetValues, > > > > > > > > I have set up my code to print the column argument (n) of > > MatSetValues and in this case is 7 (lower than 124), it still > > gives error, even entering a specific number in the MatSetValues > > column argument position gives the same error. > > > > > > > > So next i went back to ex.50 here: > > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/ > tutorials/ex50.c.html > > tutorials/ex50.c.html> > > and it has a very similar structure except the PetscMalloc1() > > call, so i tried adding that and got: > > > > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined > > reference to `petscmalloc1_' > > > > > > > > Any ideas on this behaviour? > > > > > > > > Thanks so much, > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > > > wrote: > > > > > > > > Column too large: col 10980 max 124 > > > > > > > > You need to check the code that is generating the matrix > > entries. The matrix has 124 columns but you are attempting to > > put a value at column 10980 > > > > > > > > Barry > > > > > > > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera > > > wrote: > > > > > > > > > > Thanks Matthew and Barry, > > > > > > > > > > Now my code looks like: > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > call MatSetFromOptions(A,ierr) > > > > > call MatSetUp(A,ierr) > > > > > [...] > > > > > call > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), > INSERT_VALUES,ierr) > > > > > [...] > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > And i get a different error, now is: > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > -------------------------------------------------------------- > > > > > [0]PETSC ERROR: Argument out of range > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > > > [0]PETSC ERROR: See > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > for > > trouble shooting. > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 > > by valera Wed Aug 15 19:40:00 2018 > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > > > wrote: > > > > > > > > > > Should be > > > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > > > and remove the rest. You need to set the type of Mat > > you want the DM to return BEFORE you create the matrix. > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera > > > wrote: > > > > > > > > > > > > Ok thanks for clarifying that, i wasn't sure if there > > were different types, > > > > > > > > > > > > Here is a stripped down version of my code, it seems > > like the preallocation is working now since the matrix > > population part is working without problem, but here it is for > > illustration purposes: > > > > > > > > > > > > call DMSetMatrixPreallocateOnly( > daDummy,PETSC_TRUE,ierr) > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > call MatSetFromOptions(A,ierr) > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > call > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > call MatSetUp(A,ierr) > > > > > > [...] > > > > > > call > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), > INSERT_VALUES,ierr) > > > > > > [...] > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > Adding the first line there did the trick, > > > > > > > > > > > > Now the problem seems to be the program is not > > recognizing the matrix as ViennaCL type when i try with more > > than one processor, i get now: > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > -------------------------------------------------------------- > > > > > > [0]PETSC ERROR: No support for this operation for this > > object type > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > > > [0]PETSC ERROR: See > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > for > > trouble shooting. > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > node50 by valera Wed Aug 15 14:44:22 2018 > > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > > > > > When running with: > > > > > > > > > > > > mpirun -n 1 ./gcmLEP.GPU > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > > > wrote: > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > > > wrote: > > > > > > It seems to be resumed on: I do not know how to > > preallocate a DM Matrix correctly. > > > > > > > > > > > > There is only one matrix type, Mat. There are no > > separate DM matrices. A DM can create a matrix for you > > > > > > using DMCreateMatrix(), but that is a Mat and it is > > preallocated correctly. I am not sure what you are doing. > > > > > > > > > > > > Thanks, > > > > > > > > > > > > Matt > > > > > > > > > > > > The interesting part is that it only breaks when i need > > to populate a GPU matrix from MPI, so kudos on that, but it > > seems i need to do better on my code to get this setup working, > > > > > > > > > > > > Any help would be appreciated, > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > > > wrote: > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > > > wrote: > > > > > > Thanks Matthew, > > > > > > > > > > > > I try to do that when calling: > > > > > > > > > > > > call > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > > > > > > > But i am not aware on how to do this for the DM if it > > needs something more specific/different, > > > > > > > > > > > > The error says that your preallocation is wrong for the > > values you are putting in. The DM does not control either, > > > > > > so I do not understand your email. > > > > > > > > > > > > Thanks, > > > > > > > > > > > > Matt > > > > > > > > > > > > Thanks, > > > > > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > > > wrote: > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > > > wrote: > > > > > > Hello PETSc devs, > > > > > > > > > > > > I am running into an error when trying to use the > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs > > for MATSEQAIJVIENNACL type in one processor. The error happens > > when calling MatSetValues for this specific configuration. It > > does not occur when using MPI DMMatrix types only. > > > > > > > > > > > > The DM properly preallocates the matrix. I am assuming > > you do not here. > > > > > > > > > > > > Matt > > > > > > > > > > > > Any help will be appreciated, > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > My program call: > > > > > > > > > > > > mpirun -n 2 ./gcmLEP.GPU > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > > > > > [1]PETSC ERROR: --------------------- Error Message > > -------------------------------------------------------------- > > > > > > [1]PETSC ERROR: Argument out of range > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global > > row/column (75, 50) into matrix > > > > > > [1]PETSC ERROR: See > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > for > > trouble shooting. > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > node50 by valera Wed Aug 15 13:10:44 2018 > > > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > My Code structure: > > > > > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > call MatSetFromOptions(A,ierr) > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > > > > if (numprocs > 1) then ! set matrix type parallel > > > > > > ! Get local size > > > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > > > call VecDestroy(Tmpnat,ierr) > > > > > > ! Set matrix > > > > > > #ifdef GPU > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > print*,'SETTING GPU TYPES' > > > > > > #else > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > > > > #endif > > > > > > call > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > else ! set matrix type sequential > > > > > > #ifdef GPU > > > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > > > print*,'SETTING GPU TYPES' > > > > > > #else > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > > > > call MatSetType(A,MATSEQAIJ,ierr) > > > > > > #endif > > > > > > call MatSetUp(A,ierr) > > > > > > call > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > > > > > do k=zstart,zend-1 > > > > > > do j=ystart,yend-1 > > > > > > do i=xstart,xend-1 > > > > > > [..] > > > > > > call > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), > INSERT_VALUES,ierr) > > > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > 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 > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > 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 > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > 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 > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 29 15:29:15 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 29 Aug 2018 20:29:15 +0000 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> Message-ID: <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> > On Aug 29, 2018, at 3:26 PM, Manuel Valera wrote: > > > > You may need to use just plain PCBJACOBI or PCASM for parallelism and then SAVIENNACL sequentially on each block. > > > Can you elaborate a little in how to do this? do you mean i can only use viennacl in serial at the moment or this is a suggestion of a workaround on how to make it work? -pc_type bjacobi -sub_pc_type SAVIENNACL This will run in parallel and utilize the GPU for each block of the preconditioner. Barry > > > Thanks, > > > > > > > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera wrote: > > > > Hi everyone, > > > > Thanks for your responses, i understand communicating on this way to this level of technicality can be hard, i still think we can work ways to solve this problem though, > > > > I can say the following at this point: > > > > ? Program works without issues in any other non-gpu preconditioner, just by calling -pc_type ### . > > ? Program works correctly with ViennaCL preconditioners with mpirun -n 1, that is on one processor. > > ? Program breaks with every ViennaCL preconditioner when attempting any more than 1 processors. > > ? I haven't tried other GPU preconditioners because ViennaCL gave the best performance in 1 processor before. > > ? I have made sure the matrix type is mpiaijviennacl as it is printed right before the error log. > > ? I am attaching what i think are the backtrace logs of the run with two cores, as i have limited experience with this kind of debugging, and i cannot make sense of what they say, please let me know if you need me to do something else. > > > > Current options i can think of are giving you permission to clone my model repo, or for you to guide me trough the process remotely, > > > > Thanks, > > > > .-.-.-.- > > > > > > The error i get is still: > > > > Matrix type: mpiaijviennacl > > Of sizes: 125 x 125 > > Matrix type: mpiaijviennacl > > Of sizes: 125 x 125 > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [0]PETSC ERROR: No support for this operation for this object type > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > [1]PETSC ERROR: ------------------------------------------------------------------------ > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > -------------------------------------------------------------------------- > > MPI_ABORT was invoked on rank 1 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. > > -------------------------------------------------------------------------- > > [0]PETSC ERROR: ------------------------------------------------------------------------ > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > > [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. > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 /home/valera/petsc/src/mat/utils/gcreate.c > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [0]PETSC ERROR: Signal received > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file > > [node50:32783] 1 more process has sent help message help-mpi-api.txt / mpi-abort > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp wrote: > > Hi Manuel, > > > > as Barry said, it is hard for us to provide any help without having a more complete picture of what is going on. > > > > The error you report seems to come from the AMG preconditioner in ViennaCL. This can have many origins. Do other preconditioners run without error? Can you run in a debugger and provide a complete backtrace? > > > > Thanks and best regards, > > Karli > > > > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: > > Talked too fast, > > > > After fixing that problem, i tried more than one mpi processor and got the following: > > > > Matrix type: mpiaijviennacl > > Of sizes: 125 x 125 > > Matrix type: mpiaijviennacl > > Of sizes: 125 x 125 > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [0]PETSC ERROR: No support for this operation for this object type > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > [1]PETSC ERROR: ------------------------------------------------------------------------ > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > -------------------------------------------------------------------------- > > MPI_ABORT was invoked on rank 1 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. > > -------------------------------------------------------------------------- > > [0]PETSC ERROR: ------------------------------------------------------------------------ > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > > [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. > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 /home/valera/petsc/src/sys/objects/tagm.c > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 /home/valera/petsc/src/sys/objects/inherit.c > > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/is/interface/isreg.c > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 /home/valera/petsc/src/vec/is/is/impls/general/general.c > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [0]PETSC ERROR: Signal received > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > > [node50:30582] 1 more process has sent help message help-mpi-api.txt / mpi-abort > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > > > > > It is currently running in 1 mpi processor + GPU but i would like to call at least 16 mpi processors + GPU to do the rest of the data management who is not part of the main laplacian on the mpi and the laplacian solution on the GPU, is this currently possible? > > > > Thanks for your help, > > > > > > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > wrote: > > > > Ok, i found the culprit and we can close this thread, > > > > The problem was a missing variable for setting the maximum columns, > > which i deleted at some point without realizing. The error message > > was too ambiguous to catch this so i had to compare with a previous > > working version of the arguments of MatSetValues, it was evident then. > > > > Good news is that i can now set the values with the viennacl types too, > > > > Thanks for your kind help, > > > > Manuel > > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. > > > wrote: > > > > > > 1) PetscMalloc() is never valid or needed in Fortran > > > > 2) there is no reason to use DMSetMatrixPreallocateOnly() > > just use DMCreateMatrix() assuming that using a DM (DMDA, > > DMPLEX, etc) is suitable for your problem. > > > > At this end we are totally guessing at what you are doing > > and so have little help we can provide. A simple, nonworking > > code that tries to do what you would need would help us a great > > deal in understanding that you are trying to do. > > > > Barry > > > > > > > > > > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera > > > wrote: > > > > > > Matthew, PetscMalloc gives the same error, > > > > > > Barry, it would be very hard for me to get the code to a > > minimum working example, i guess all i need to understand is how > > to setup a DM matrix with DMSetMatrixPreallocateOnly() instead > > of MatMPIAIJSetPreallocation() as we were doing before, is there > > a simple example who does this in Fortran? > > > > > > Is the PetscMalloc call needed? is 'call > > PetscMalloc(1,row,ierr)' a valid, compilable call to > > PetscMalloc? what other reason may there be for this error to > > happen ? > > > > > > Just remembering, that trying to setup the matrix with the > > MatAIJSetPreallocation() brings up an error to acknowledge the > > viennacl datatypes and that's why i'm trying to make this change > > on your recommendation, > > > > > > Thanks for your help, > > > > > > > > > > > > > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. > > > wrote: > > > > > > Send your code in a way we can compile and run it; it must > > be some simple issue that is hard to communicate in email. > > > > > > Barry > > > > > > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera > > > wrote: > > > > > > > > Hello everyone, > > > > > > > > I just had time to work on this again, and checked the code > > for errors on the matrix entries, this is the exact code i was > > using for creating the matrix without > > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and > > it worked that way, but trying this way i get the same 'Column > > too large' error using any number at the column position of > > MatSetValues, > > > > > > > > I have set up my code to print the column argument (n) of > > MatSetValues and in this case is 7 (lower than 124), it still > > gives error, even entering a specific number in the MatSetValues > > column argument position gives the same error. > > > > > > > > So next i went back to ex.50 here: > > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html > > > > and it has a very similar structure except the PetscMalloc1() > > call, so i tried adding that and got: > > > > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined > > reference to `petscmalloc1_' > > > > > > > > Any ideas on this behaviour? > > > > > > > > Thanks so much, > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > > > wrote: > > > > > > > > Column too large: col 10980 max 124 > > > > > > > > You need to check the code that is generating the matrix > > entries. The matrix has 124 columns but you are attempting to > > put a value at column 10980 > > > > > > > > Barry > > > > > > > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera > > > wrote: > > > > > > > > > > Thanks Matthew and Barry, > > > > > > > > > > Now my code looks like: > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > call MatSetFromOptions(A,ierr) > > > > > call MatSetUp(A,ierr) > > > > > [...] > > > > > call > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > [...] > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > And i get a different error, now is: > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > -------------------------------------------------------------- > > > > > [0]PETSC ERROR: Argument out of range > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > > > [0]PETSC ERROR: See > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > for > > trouble shooting. > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 > > by valera Wed Aug 15 19:40:00 2018 > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > > > wrote: > > > > > > > > > > Should be > > > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > > > and remove the rest. You need to set the type of Mat > > you want the DM to return BEFORE you create the matrix. > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera > > > wrote: > > > > > > > > > > > > Ok thanks for clarifying that, i wasn't sure if there > > were different types, > > > > > > > > > > > > Here is a stripped down version of my code, it seems > > like the preallocation is working now since the matrix > > population part is working without problem, but here it is for > > illustration purposes: > > > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > call MatSetFromOptions(A,ierr) > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > call > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > call MatSetUp(A,ierr) > > > > > > [...] > > > > > > call > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > [...] > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > Adding the first line there did the trick, > > > > > > > > > > > > Now the problem seems to be the program is not > > recognizing the matrix as ViennaCL type when i try with more > > than one processor, i get now: > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > -------------------------------------------------------------- > > > > > > [0]PETSC ERROR: No support for this operation for this > > object type > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > > > [0]PETSC ERROR: See > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > for > > trouble shooting. > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > node50 by valera Wed Aug 15 14:44:22 2018 > > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > > > > > When running with: > > > > > > > > > > > > mpirun -n 1 ./gcmLEP.GPU > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > > > wrote: > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > > > wrote: > > > > > > It seems to be resumed on: I do not know how to > > preallocate a DM Matrix correctly. > > > > > > > > > > > > There is only one matrix type, Mat. There are no > > separate DM matrices. A DM can create a matrix for you > > > > > > using DMCreateMatrix(), but that is a Mat and it is > > preallocated correctly. I am not sure what you are doing. > > > > > > > > > > > > Thanks, > > > > > > > > > > > > Matt > > > > > > > > > > > > The interesting part is that it only breaks when i need > > to populate a GPU matrix from MPI, so kudos on that, but it > > seems i need to do better on my code to get this setup working, > > > > > > > > > > > > Any help would be appreciated, > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > > > wrote: > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > > > wrote: > > > > > > Thanks Matthew, > > > > > > > > > > > > I try to do that when calling: > > > > > > > > > > > > call > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > > > > > But i am not aware on how to do this for the DM if it > > needs something more specific/different, > > > > > > > > > > > > The error says that your preallocation is wrong for the > > values you are putting in. The DM does not control either, > > > > > > so I do not understand your email. > > > > > > > > > > > > Thanks, > > > > > > > > > > > > Matt > > > > > > > > > > > > Thanks, > > > > > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > > > wrote: > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > > > wrote: > > > > > > Hello PETSc devs, > > > > > > > > > > > > I am running into an error when trying to use the > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs > > for MATSEQAIJVIENNACL type in one processor. The error happens > > when calling MatSetValues for this specific configuration. It > > does not occur when using MPI DMMatrix types only. > > > > > > > > > > > > The DM properly preallocates the matrix. I am assuming > > you do not here. > > > > > > > > > > > > Matt > > > > > > > > > > > > Any help will be appreciated, > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > My program call: > > > > > > > > > > > > mpirun -n 2 ./gcmLEP.GPU > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > > > > > [1]PETSC ERROR: --------------------- Error Message > > -------------------------------------------------------------- > > > > > > [1]PETSC ERROR: Argument out of range > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global > > row/column (75, 50) into matrix > > > > > > [1]PETSC ERROR: See > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > for > > trouble shooting. > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > node50 by valera Wed Aug 15 13:10:44 2018 > > > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > My Code structure: > > > > > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > call MatSetFromOptions(A,ierr) > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > > > > if (numprocs > 1) then ! set matrix type parallel > > > > > > ! Get local size > > > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > > > call VecDestroy(Tmpnat,ierr) > > > > > > ! Set matrix > > > > > > #ifdef GPU > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > print*,'SETTING GPU TYPES' > > > > > > #else > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > > > > #endif > > > > > > call > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > else ! set matrix type sequential > > > > > > #ifdef GPU > > > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > > > print*,'SETTING GPU TYPES' > > > > > > #else > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > > > > call MatSetType(A,MATSEQAIJ,ierr) > > > > > > #endif > > > > > > call MatSetUp(A,ierr) > > > > > > call > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > > > > > do k=zstart,zend-1 > > > > > > do j=ystart,yend-1 > > > > > > do i=xstart,xend-1 > > > > > > [..] > > > > > > call > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > 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 > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > 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 > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > 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 > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > From mvalera-w at sdsu.edu Wed Aug 29 15:37:29 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 29 Aug 2018 13:37:29 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: Awesome, thanks! On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. wrote: > > > > On Aug 29, 2018, at 3:26 PM, Manuel Valera wrote: > > > > > > > > You may need to use just plain PCBJACOBI or PCASM for parallelism and > then SAVIENNACL sequentially on each block. > > > > > > Can you elaborate a little in how to do this? do you mean i can only use > viennacl in serial at the moment or this is a suggestion of a workaround on > how to make it work? > > -pc_type bjacobi -sub_pc_type SAVIENNACL > > This will run in parallel and utilize the GPU for each block of the > preconditioner. > > Barry > > > > > > > Thanks, > > > > > > > > > > > > > > > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera wrote: > > > > > > Hi everyone, > > > > > > Thanks for your responses, i understand communicating on this way to > this level of technicality can be hard, i still think we can work ways to > solve this problem though, > > > > > > I can say the following at this point: > > > > > > ? Program works without issues in any other non-gpu > preconditioner, just by calling -pc_type ### . > > > ? Program works correctly with ViennaCL preconditioners with > mpirun -n 1, that is on one processor. > > > ? Program breaks with every ViennaCL preconditioner when > attempting any more than 1 processors. > > > ? I haven't tried other GPU preconditioners because ViennaCL > gave the best performance in 1 processor before. > > > ? I have made sure the matrix type is mpiaijviennacl as it is > printed right before the error log. > > > ? I am attaching what i think are the backtrace logs of the run > with two cores, as i have limited experience with this kind of debugging, > and i cannot make sense of what they say, please let me know if you need me > to do something else. > > > > > > Current options i can think of are giving you permission to clone my > model repo, or for you to guide me trough the process remotely, > > > > > > Thanks, > > > > > > .-.-.-.- > > > > > > > > > The error i get is still: > > > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > [0]PETSC ERROR: No support for this operation for this object type > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Wed Aug 29 11:43:25 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ > ksp/interface/itfunc.c > > > [1]PETSC ERROR: ------------------------------ > ------------------------------------------ > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > probably memory access out of range > > > [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] PetscTraceBackErrorHandler line 182 > /home/valera/petsc/src/sys/error/errtrace.c > > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/ > error/err.c > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Wed Aug 29 11:43:25 2018 > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > > ------------------------------------------------------------ > -------------- > > > MPI_ABORT was invoked on rank 1 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. > > > ------------------------------------------------------------ > -------------- > > > [0]PETSC ERROR: ------------------------------ > ------------------------------------------ > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or > the batch system) has told this process to end > > > [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. > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 > /home/valera/petsc/src/mat/utils/gcreate.c > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ > ksp/interface/itfunc.c > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > [0]PETSC ERROR: Signal received > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Wed Aug 29 11:43:25 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file > > > [node50:32783] 1 more process has sent help message help-mpi-api.txt / > mpi-abort > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to > see all help / error messages > > > > > > > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp > wrote: > > > Hi Manuel, > > > > > > as Barry said, it is hard for us to provide any help without having a > more complete picture of what is going on. > > > > > > The error you report seems to come from the AMG preconditioner in > ViennaCL. This can have many origins. Do other preconditioners run without > error? Can you run in a debugger and provide a complete backtrace? > > > > > > Thanks and best regards, > > > Karli > > > > > > > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: > > > Talked too fast, > > > > > > After fixing that problem, i tried more than one mpi processor and got > the following: > > > > > > Matrix type: mpiaijviennacl > > > Of sizes: 125 x 125 > > > Matrix type: mpiaijviennacl > > > Of sizes: 125 x 125 > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > [0]PETSC ERROR: No support for this operation for this object type > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Tue Aug 28 16:30:02 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < > http://saviennacl.cu> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > [1]PETSC ERROR: ------------------------------ > ------------------------------------------ > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > probably memory access out of range > > > [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] PetscTraceBackErrorHandler line 182 > /home/valera/petsc/src/sys/error/errtrace.c > > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/ > error/err.c > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< > http://saviennacl.cu> > > > > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Tue Aug 28 16:30:02 2018 > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > > ------------------------------------------------------------ > -------------- > > > MPI_ABORT was invoked on rank 1 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. > > > ------------------------------------------------------------ > -------------- > > > [0]PETSC ERROR: ------------------------------ > ------------------------------------------ > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or > the batch system) has told this process to end > > > [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. > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 > /home/valera/petsc/src/sys/objects/tagm.c > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 > /home/valera/petsc/src/sys/objects/inherit.c > > > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/ > is/interface/isreg.c > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 > /home/valera/petsc/src/vec/is/is/impls/general/general.c > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< > http://saviennacl.cu> > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > [0]PETSC ERROR: Signal received > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Tue Aug 28 16:30:02 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > > > [node50:30582] 1 more process has sent help message help-mpi-api.txt / > mpi-abort > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to > see all help / error messages > > > > > > > > > > > > It is currently running in 1 mpi processor + GPU but i would like to > call at least 16 mpi processors + GPU to do the rest of the data management > who is not part of the main laplacian on the mpi and the laplacian solution > on the GPU, is this currently possible? > > > > > > Thanks for your help, > > > > > > > > > > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > wrote: > > > > > > Ok, i found the culprit and we can close this thread, > > > > > > The problem was a missing variable for setting the maximum columns, > > > which i deleted at some point without realizing. The error message > > > was too ambiguous to catch this so i had to compare with a previous > > > working version of the arguments of MatSetValues, it was evident > then. > > > > > > Good news is that i can now set the values with the viennacl types > too, > > > > > > Thanks for your kind help, > > > > > > Manuel > > > > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. > > > > wrote: > > > > > > > > > 1) PetscMalloc() is never valid or needed in Fortran > > > > > > 2) there is no reason to use DMSetMatrixPreallocateOnly() > > > just use DMCreateMatrix() assuming that using a DM (DMDA, > > > DMPLEX, etc) is suitable for your problem. > > > > > > At this end we are totally guessing at what you are doing > > > and so have little help we can provide. A simple, nonworking > > > code that tries to do what you would need would help us a great > > > deal in understanding that you are trying to do. > > > > > > Barry > > > > > > > > > > > > > > > > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera > > > > wrote: > > > > > > > > Matthew, PetscMalloc gives the same error, > > > > > > > > Barry, it would be very hard for me to get the code to a > > > minimum working example, i guess all i need to understand is > how > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() instead > > > of MatMPIAIJSetPreallocation() as we were doing before, is > there > > > a simple example who does this in Fortran? > > > > > > > > Is the PetscMalloc call needed? is 'call > > > PetscMalloc(1,row,ierr)' a valid, compilable call to > > > PetscMalloc? what other reason may there be for this error to > > > happen ? > > > > > > > > Just remembering, that trying to setup the matrix with the > > > MatAIJSetPreallocation() brings up an error to acknowledge the > > > viennacl datatypes and that's why i'm trying to make this > change > > > on your recommendation, > > > > > > > > Thanks for your help, > > > > > > > > > > > > > > > > > > > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. > > > > wrote: > > > > > > > > Send your code in a way we can compile and run it; it > must > > > be some simple issue that is hard to communicate in email. > > > > > > > > Barry > > > > > > > > > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera > > > > wrote: > > > > > > > > > > Hello everyone, > > > > > > > > > > I just had time to work on this again, and checked the > code > > > for errors on the matrix entries, this is the exact code i was > > > using for creating the matrix without > > > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and > > > it worked that way, but trying this way i get the same 'Column > > > too large' error using any number at the column position of > > > MatSetValues, > > > > > > > > > > I have set up my code to print the column argument (n) of > > > MatSetValues and in this case is 7 (lower than 124), it still > > > gives error, even entering a specific number in the > MatSetValues > > > column argument position gives the same error. > > > > > > > > > > So next i went back to ex.50 here: > > > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/ > tutorials/ex50.c.html > > > tutorials/ex50.c.html> > > > and it has a very similar structure except the PetscMalloc1() > > > call, so i tried adding that and got: > > > > > > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: > undefined > > > reference to `petscmalloc1_' > > > > > > > > > > Any ideas on this behaviour? > > > > > > > > > > Thanks so much, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > > > > wrote: > > > > > > > > > > Column too large: col 10980 max 124 > > > > > > > > > > You need to check the code that is generating the > matrix > > > entries. The matrix has 124 columns but you are attempting to > > > put a value at column 10980 > > > > > > > > > > Barry > > > > > > > > > > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera > > > > wrote: > > > > > > > > > > > > Thanks Matthew and Barry, > > > > > > > > > > > > Now my code looks like: > > > > > > > > > > > > call DMSetMatrixPreallocateOnly( > daDummy,PETSC_TRUE,ierr) > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > call MatSetFromOptions(A,ierr) > > > > > > call MatSetUp(A,ierr) > > > > > > [...] > > > > > > call > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), > INSERT_VALUES,ierr) > > > > > > [...] > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > And i get a different error, now is: > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > > -------------------------------------------------------------- > > > > > > [0]PETSC ERROR: Argument out of range > > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > > > > [0]PETSC ERROR: See > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > for > > > trouble shooting. > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > node50 > > > by valera Wed Aug 15 19:40:00 2018 > > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > > > > wrote: > > > > > > > > > > > > Should be > > > > > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > > > > > and remove the rest. You need to set the type of Mat > > > you want the DM to return BEFORE you create the matrix. > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera > > > > wrote: > > > > > > > > > > > > > > Ok thanks for clarifying that, i wasn't sure if there > > > were different types, > > > > > > > > > > > > > > Here is a stripped down version of my code, it seems > > > like the preallocation is working now since the matrix > > > population part is working without problem, but here it is for > > > illustration purposes: > > > > > > > > > > > > > > call DMSetMatrixPreallocateOnly( > daDummy,PETSC_TRUE,ierr) > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > call > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > > call MatSetUp(A,ierr) > > > > > > > [...] > > > > > > > call > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), > INSERT_VALUES,ierr) > > > > > > > [...] > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > > > Adding the first line there did the trick, > > > > > > > > > > > > > > Now the problem seems to be the program is not > > > recognizing the matrix as ViennaCL type when i try with more > > > than one processor, i get now: > > > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > > -------------------------------------------------------------- > > > > > > > [0]PETSC ERROR: No support for this operation for this > > > object type > > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL > matrices > > > > > > > [0]PETSC ERROR: See > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > for > > > trouble shooting. > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > > node50 by valera Wed Aug 15 14:44:22 2018 > > > > > > > [0]PETSC ERROR: Configure options > PETSC_ARCH=cuda-debug > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennac > l.cu > > > > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > > > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > > > > > > > When running with: > > > > > > > > > > > > > > mpirun -n 1 ./gcmLEP.GPU > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > > > > wrote: > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > > > > wrote: > > > > > > > It seems to be resumed on: I do not know how to > > > preallocate a DM Matrix correctly. > > > > > > > > > > > > > > There is only one matrix type, Mat. There are no > > > separate DM matrices. A DM can create a matrix for you > > > > > > > using DMCreateMatrix(), but that is a Mat and it is > > > preallocated correctly. I am not sure what you are doing. > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > The interesting part is that it only breaks when i > need > > > to populate a GPU matrix from MPI, so kudos on that, but it > > > seems i need to do better on my code to get this setup working, > > > > > > > > > > > > > > Any help would be appreciated, > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > > > > wrote: > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > > > > wrote: > > > > > > > Thanks Matthew, > > > > > > > > > > > > > > I try to do that when calling: > > > > > > > > > > > > > > call > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > > > > > > > > > But i am not aware on how to do this for the DM if it > > > needs something more specific/different, > > > > > > > > > > > > > > The error says that your preallocation is wrong for > the > > > values you are putting in. The DM does not control either, > > > > > > > so I do not understand your email. > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > > > > wrote: > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > > > > wrote: > > > > > > > Hello PETSc devs, > > > > > > > > > > > > > > I am running into an error when trying to use the > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs > > > for MATSEQAIJVIENNACL type in one processor. The error happens > > > when calling MatSetValues for this specific configuration. It > > > does not occur when using MPI DMMatrix types only. > > > > > > > > > > > > > > The DM properly preallocates the matrix. I am assuming > > > you do not here. > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > Any help will be appreciated, > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > My program call: > > > > > > > > > > > > > > mpirun -n 2 ./gcmLEP.GPU > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > > > > > > > [1]PETSC ERROR: --------------------- Error Message > > > -------------------------------------------------------------- > > > > > > > [1]PETSC ERROR: Argument out of range > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global > > > row/column (75, 50) into matrix > > > > > > > [1]PETSC ERROR: See > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > for > > > trouble shooting. > > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > > node50 by valera Wed Aug 15 13:10:44 2018 > > > > > > > [1]PETSC ERROR: Configure options > PETSC_ARCH=cuda-debug > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > > > > My Code structure: > > > > > > > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > > > > > if (numprocs > 1) then ! set matrix type parallel > > > > > > > ! Get local size > > > > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > > > > call VecDestroy(Tmpnat,ierr) > > > > > > > ! Set matrix > > > > > > > #ifdef GPU > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > print*,'SETTING GPU TYPES' > > > > > > > #else > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > > > > > #endif > > > > > > > call > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > > else ! set matrix type sequential > > > > > > > #ifdef GPU > > > > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > > > > print*,'SETTING GPU TYPES' > > > > > > > #else > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) > > > > > > > #endif > > > > > > > call MatSetUp(A,ierr) > > > > > > > call > > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > > > > > > > do k=zstart,zend-1 > > > > > > > do j=ystart,yend-1 > > > > > > > do i=xstart,xend-1 > > > > > > > [..] > > > > > > > call > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), > INSERT_VALUES,ierr) > > > > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > 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 > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > 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 > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > 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 > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mvalera-w at sdsu.edu Wed Aug 29 15:40:37 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 29 Aug 2018 13:40:37 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: Yeah, no sorry, i get the same error with -pc_type bjacobi -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" Thanks and let me know of any progress on this issue, On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera wrote: > Awesome, thanks! > > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. > wrote: > >> >> >> > On Aug 29, 2018, at 3:26 PM, Manuel Valera wrote: >> > >> > >> > >> > You may need to use just plain PCBJACOBI or PCASM for parallelism and >> then SAVIENNACL sequentially on each block. >> > >> > >> > Can you elaborate a little in how to do this? do you mean i can only >> use viennacl in serial at the moment or this is a suggestion of a >> workaround on how to make it work? >> >> -pc_type bjacobi -sub_pc_type SAVIENNACL >> >> This will run in parallel and utilize the GPU for each block of the >> preconditioner. >> >> Barry >> >> > >> > >> > Thanks, >> > >> > >> > >> > >> > >> > >> > >> > > On Aug 29, 2018, at 1:50 PM, Manuel Valera >> wrote: >> > > >> > > Hi everyone, >> > > >> > > Thanks for your responses, i understand communicating on this way to >> this level of technicality can be hard, i still think we can work ways to >> solve this problem though, >> > > >> > > I can say the following at this point: >> > > >> > > ? Program works without issues in any other non-gpu >> preconditioner, just by calling -pc_type ### . >> > > ? Program works correctly with ViennaCL preconditioners with >> mpirun -n 1, that is on one processor. >> > > ? Program breaks with every ViennaCL preconditioner when >> attempting any more than 1 processors. >> > > ? I haven't tried other GPU preconditioners because ViennaCL >> gave the best performance in 1 processor before. >> > > ? I have made sure the matrix type is mpiaijviennacl as it is >> printed right before the error log. >> > > ? I am attaching what i think are the backtrace logs of the run >> with two cores, as i have limited experience with this kind of debugging, >> and i cannot make sense of what they say, please let me know if you need me >> to do something else. >> > > >> > > Current options i can think of are giving you permission to clone my >> model repo, or for you to guide me trough the process remotely, >> > > >> > > Thanks, >> > > >> > > .-.-.-.- >> > > >> > > >> > > The error i get is still: >> > > >> > > Matrix type: mpiaijviennacl >> >> > > Of sizes: 125 x 125 >> > > Matrix type: mpiaijviennacl >> >> > > Of sizes: 125 x 125 >> > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > [0]PETSC ERROR: No support for this operation for this object type >> > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >> > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Wed Aug 29 11:43:25 2018 >> > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >> /home/valera/petsc/src/ksp/pc/interface/precon.c >> > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >> > > [1]PETSC ERROR: ------------------------------ >> ------------------------------------------ >> > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, >> probably memory access out of range >> > > [1]PETSC ERROR: Try option -start_in_debugger or >> -on_error_attach_debugger >> > > [1]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >> ocumentation/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] PetscTraceBackErrorHandler line 182 >> /home/valera/petsc/src/sys/error/errtrace.c >> > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/err >> or/err.c >> > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> > > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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/d >> ocumentation/faq.html for trouble shooting. >> > > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Wed Aug 29 11:43:25 2018 >> > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >> > > ------------------------------------------------------------ >> -------------- >> > > MPI_ABORT was invoked on rank 1 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. >> > > ------------------------------------------------------------ >> -------------- >> > > [0]PETSC ERROR: ------------------------------ >> ------------------------------------------ >> > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or >> the batch system) has told this process to end >> > > [0]PETSC ERROR: Try option -start_in_debugger or >> -on_error_attach_debugger >> > > [0]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >> ocumentation/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. >> > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 >> /home/valera/petsc/src/mat/utils/gcreate.c >> > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> > > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ksp >> /interface/itfunc.c >> > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > [0]PETSC ERROR: Signal received >> > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Wed Aug 29 11:43:25 2018 >> > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file >> > > [node50:32783] 1 more process has sent help message help-mpi-api.txt >> / mpi-abort >> > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to >> see all help / error messages >> > > >> > > >> > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp >> wrote: >> > > Hi Manuel, >> > > >> > > as Barry said, it is hard for us to provide any help without having a >> more complete picture of what is going on. >> > > >> > > The error you report seems to come from the AMG preconditioner in >> ViennaCL. This can have many origins. Do other preconditioners run without >> error? Can you run in a debugger and provide a complete backtrace? >> > > >> > > Thanks and best regards, >> > > Karli >> > > >> > > >> > > On 08/29/2018 01:33 AM, Manuel Valera wrote: >> > > Talked too fast, >> > > >> > > After fixing that problem, i tried more than one mpi processor and >> got the following: >> > > >> > > Matrix type: mpiaijviennacl >> > > Of sizes: 125 x 125 >> > > Matrix type: mpiaijviennacl >> > > Of sizes: 125 x 125 >> > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > [0]PETSC ERROR: No support for this operation for this object type >> > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >> > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Tue Aug 28 16:30:02 2018 >> > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >> http://saviennacl.cu> >> > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >> /home/valera/petsc/src/ksp/pc/interface/precon.c >> > > [1]PETSC ERROR: ------------------------------ >> ------------------------------------------ >> > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, >> probably memory access out of range >> > > [1]PETSC ERROR: Try option -start_in_debugger or >> -on_error_attach_debugger >> > > [1]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >> ocumentation/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] PetscTraceBackErrorHandler line 182 >> /home/valera/petsc/src/sys/error/errtrace.c >> > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/err >> or/err.c >> > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >> http://saviennacl.cu> >> > > >> > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> > > [1]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > [1]PETSC ERROR: Signal received >> > > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > [1]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Tue Aug 28 16:30:02 2018 >> > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >> > > ------------------------------------------------------------ >> -------------- >> > > MPI_ABORT was invoked on rank 1 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. >> > > ------------------------------------------------------------ >> -------------- >> > > [0]PETSC ERROR: ------------------------------ >> ------------------------------------------ >> > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or >> the batch system) has told this process to end >> > > [0]PETSC ERROR: Try option -start_in_debugger or >> -on_error_attach_debugger >> > > [0]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >> ocumentation/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. >> > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >> /home/valera/petsc/src/sys/objects/tagm.c >> > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >> /home/valera/petsc/src/sys/objects/inherit.c >> > > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/ >> is/interface/isreg.c >> > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 >> /home/valera/petsc/src/vec/is/is/impls/general/general.c >> > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >> http://saviennacl.cu> >> > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > [0]PETSC ERROR: Signal received >> > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 >> GIT Date: 2018-05-31 17:31:13 +0300 >> > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Tue Aug 28 16:30:02 2018 >> > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >> > > [node50:30582] 1 more process has sent help message help-mpi-api.txt >> / mpi-abort >> > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to >> see all help / error messages >> > > >> > > >> > > >> > > It is currently running in 1 mpi processor + GPU but i would like to >> call at least 16 mpi processors + GPU to do the rest of the data management >> who is not part of the main laplacian on the mpi and the laplacian solution >> on the GPU, is this currently possible? >> > > >> > > Thanks for your help, >> > > >> > > >> > > >> > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > > wrote: >> > > >> > > Ok, i found the culprit and we can close this thread, >> > > >> > > The problem was a missing variable for setting the maximum >> columns, >> > > which i deleted at some point without realizing. The error message >> > > was too ambiguous to catch this so i had to compare with a >> previous >> > > working version of the arguments of MatSetValues, it was evident >> then. >> > > >> > > Good news is that i can now set the values with the viennacl >> types too, >> > > >> > > Thanks for your kind help, >> > > >> > > Manuel >> > > >> > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >> > > > wrote: >> > > >> > > >> > > 1) PetscMalloc() is never valid or needed in Fortran >> > > >> > > 2) there is no reason to use DMSetMatrixPreallocateOnly() >> > > just use DMCreateMatrix() assuming that using a DM (DMDA, >> > > DMPLEX, etc) is suitable for your problem. >> > > >> > > At this end we are totally guessing at what you are doing >> > > and so have little help we can provide. A simple, nonworking >> > > code that tries to do what you would need would help us a >> great >> > > deal in understanding that you are trying to do. >> > > >> > > Barry >> > > >> > > >> > > >> > > >> > > >> > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera >> > > > wrote: >> > > > >> > > > Matthew, PetscMalloc gives the same error, >> > > > >> > > > Barry, it would be very hard for me to get the code to a >> > > minimum working example, i guess all i need to understand is >> how >> > > to setup a DM matrix with DMSetMatrixPreallocateOnly() instead >> > > of MatMPIAIJSetPreallocation() as we were doing before, is >> there >> > > a simple example who does this in Fortran? >> > > > >> > > > Is the PetscMalloc call needed? is 'call >> > > PetscMalloc(1,row,ierr)' a valid, compilable call to >> > > PetscMalloc? what other reason may there be for this error to >> > > happen ? >> > > > >> > > > Just remembering, that trying to setup the matrix with the >> > > MatAIJSetPreallocation() brings up an error to acknowledge the >> > > viennacl datatypes and that's why i'm trying to make this >> change >> > > on your recommendation, >> > > > >> > > > Thanks for your help, >> > > > >> > > > >> > > > >> > > > >> > > > >> > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >> > > > wrote: >> > > > >> > > > Send your code in a way we can compile and run it; it >> must >> > > be some simple issue that is hard to communicate in email. >> > > > >> > > > Barry >> > > > >> > > > >> > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >> > > > wrote: >> > > > > >> > > > > Hello everyone, >> > > > > >> > > > > I just had time to work on this again, and checked the >> code >> > > for errors on the matrix entries, this is the exact code i was >> > > using for creating the matrix without >> > > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation >> and >> > > it worked that way, but trying this way i get the same 'Column >> > > too large' error using any number at the column position of >> > > MatSetValues, >> > > > > >> > > > > I have set up my code to print the column argument (n) of >> > > MatSetValues and in this case is 7 (lower than 124), it still >> > > gives error, even entering a specific number in the >> MatSetValues >> > > column argument position gives the same error. >> > > > > >> > > > > So next i went back to ex.50 here: >> > > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/ >> tutorials/ex50.c.html >> > > > examples/tutorials/ex50.c.html> >> > > and it has a very similar structure except the PetscMalloc1() >> > > call, so i tried adding that and got: >> > > > > >> > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: >> undefined >> > > reference to `petscmalloc1_' >> > > > > >> > > > > Any ideas on this behaviour? >> > > > > >> > > > > Thanks so much, >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >> > > > wrote: >> > > > > >> > > > > Column too large: col 10980 max 124 >> > > > > >> > > > > You need to check the code that is generating the >> matrix >> > > entries. The matrix has 124 columns but you are attempting to >> > > put a value at column 10980 >> > > > > >> > > > > Barry >> > > > > >> > > > > >> > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >> > > > wrote: >> > > > > > >> > > > > > Thanks Matthew and Barry, >> > > > > > >> > > > > > Now my code looks like: >> > > > > > >> > > > > > call DMSetMatrixPreallocateOnly(daD >> ummy,PETSC_TRUE,ierr) >> > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > > call MatSetFromOptions(A,ierr) >> > > > > > call MatSetUp(A,ierr) >> > > > > > [...] >> > > > > > call >> > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),IN >> SERT_VALUES,ierr) >> > > > > > [...] >> > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > > >> > > > > > And i get a different error, now is: >> > > > > > >> > > > > > [0]PETSC ERROR: --------------------- Error Message >> > > ----------------------------------------------------------- >> --- >> > > > > > [0]PETSC ERROR: Argument out of range >> > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 >> > > > > > [0]PETSC ERROR: See >> > > http://www.mcs.anl.gov/petsc/documentation/faq.html >> > > for >> > > trouble shooting. >> > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >> > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >> node50 >> > > by valera Wed Aug 15 19:40:00 2018 >> > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >> > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >> > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >> > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in >> > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c >> > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >> > > /home/valera/petsc/src/mat/interface/matrix.c >> > > > > > >> > > > > > >> > > > > > Thanks again, >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. >> > > > wrote: >> > > > > > >> > > > > > Should be >> > > > > > >> > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > > >> > > > > > and remove the rest. You need to set the type of Mat >> > > you want the DM to return BEFORE you create the matrix. >> > > > > > >> > > > > > Barry >> > > > > > >> > > > > > >> > > > > > >> > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >> > > > wrote: >> > > > > > > >> > > > > > > Ok thanks for clarifying that, i wasn't sure if there >> > > were different types, >> > > > > > > >> > > > > > > Here is a stripped down version of my code, it seems >> > > like the preallocation is working now since the matrix >> > > population part is working without problem, but here it is for >> > > illustration purposes: >> > > > > > > >> > > > > > > call DMSetMatrixPreallocateOnly(daD >> ummy,PETSC_TRUE,ierr) >> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > > > call MatSetFromOptions(A,ierr) >> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > > > call >> > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > > > call MatSetUp(A,ierr) >> > > > > > > [...] >> > > > > > > call >> > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),IN >> SERT_VALUES,ierr) >> > > > > > > [...] >> > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > > > >> > > > > > > Adding the first line there did the trick, >> > > > > > > >> > > > > > > Now the problem seems to be the program is not >> > > recognizing the matrix as ViennaCL type when i try with more >> > > than one processor, i get now: >> > > > > > > >> > > > > > > [0]PETSC ERROR: --------------------- Error Message >> > > ----------------------------------------------------------- >> --- >> > > > > > > [0]PETSC ERROR: No support for this operation for >> this >> > > object type >> > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL >> matrices >> > > > > > > [0]PETSC ERROR: See >> > > http://www.mcs.anl.gov/petsc/documentation/faq.html >> > > for >> > > trouble shooting. >> > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >> > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >> > > node50 by valera Wed Aug 15 14:44:22 2018 >> > > > > > > [0]PETSC ERROR: Configure options >> PETSC_ARCH=cuda-debug >> > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >> > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >> > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >> > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/savien >> nacl.cu >> > > >> > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >> > > /home/valera/petsc/src/ksp/pc/interface/precon.c >> > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >> > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >> > > > > > > >> > > > > > > When running with: >> > > > > > > >> > > > > > > mpirun -n 1 ./gcmLEP.GPU >> > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >> > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl >> > > -pc_type saviennacl -log_view >> > > > > > > >> > > > > > > >> > > > > > > Thanks, >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley >> > > > wrote: >> > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >> > > > wrote: >> > > > > > > It seems to be resumed on: I do not know how to >> > > preallocate a DM Matrix correctly. >> > > > > > > >> > > > > > > There is only one matrix type, Mat. There are no >> > > separate DM matrices. A DM can create a matrix for you >> > > > > > > using DMCreateMatrix(), but that is a Mat and it is >> > > preallocated correctly. I am not sure what you are doing. >> > > > > > > >> > > > > > > Thanks, >> > > > > > > >> > > > > > > Matt >> > > > > > > >> > > > > > > The interesting part is that it only breaks when i >> need >> > > to populate a GPU matrix from MPI, so kudos on that, but it >> > > seems i need to do better on my code to get this setup >> working, >> > > > > > > >> > > > > > > Any help would be appreciated, >> > > > > > > >> > > > > > > Thanks, >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >> > > > wrote: >> > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >> > > > wrote: >> > > > > > > Thanks Matthew, >> > > > > > > >> > > > > > > I try to do that when calling: >> > > > > > > >> > > > > > > call >> > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > > > >> > > > > > > But i am not aware on how to do this for the DM if it >> > > needs something more specific/different, >> > > > > > > >> > > > > > > The error says that your preallocation is wrong for >> the >> > > values you are putting in. The DM does not control either, >> > > > > > > so I do not understand your email. >> > > > > > > >> > > > > > > Thanks, >> > > > > > > >> > > > > > > Matt >> > > > > > > >> > > > > > > Thanks, >> > > > > > > >> > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >> > > > wrote: >> > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >> > > > wrote: >> > > > > > > Hello PETSc devs, >> > > > > > > >> > > > > > > I am running into an error when trying to use the >> > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs >> > > for MATSEQAIJVIENNACL type in one processor. The error happens >> > > when calling MatSetValues for this specific configuration. It >> > > does not occur when using MPI DMMatrix types only. >> > > > > > > >> > > > > > > The DM properly preallocates the matrix. I am >> assuming >> > > you do not here. >> > > > > > > >> > > > > > > Matt >> > > > > > > >> > > > > > > Any help will be appreciated, >> > > > > > > >> > > > > > > Thanks, >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > My program call: >> > > > > > > >> > > > > > > mpirun -n 2 ./gcmLEP.GPU >> > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >> > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl >> > > -pc_type saviennacl -log_view >> > > > > > > >> > > > > > > >> > > > > > > The error (repeats after each MatSetValues call): >> > > > > > > >> > > > > > > [1]PETSC ERROR: --------------------- Error Message >> > > ----------------------------------------------------------- >> --- >> > > > > > > [1]PETSC ERROR: Argument out of range >> > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global >> > > row/column (75, 50) into matrix >> > > > > > > [1]PETSC ERROR: See >> > > http://www.mcs.anl.gov/petsc/documentation/faq.html >> > > for >> > > trouble shooting. >> > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: >> > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >> > > node50 by valera Wed Aug 15 13:10:44 2018 >> > > > > > > [1]PETSC ERROR: Configure options >> PETSC_ARCH=cuda-debug >> > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >> > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >> > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >> > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in >> > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >> > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >> > > /home/valera/petsc/src/mat/interface/matrix.c >> > > > > > > >> > > > > > > >> > > > > > > My Code structure: >> > > > > > > >> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > > > call MatSetFromOptions(A,ierr) >> > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) >> > > > > > > if (numprocs > 1) then ! set matrix type parallel >> > > > > > > ! Get local size >> > > > > > > call DMDACreateNaturalVector(daDumm >> y,Tmpnat,ierr) >> > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) >> > > > > > > call VecDestroy(Tmpnat,ierr) >> > > > > > > ! Set matrix >> > > > > > > #ifdef GPU >> > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >> > > > > > > call DMSetMatType(daDummy,MATMPIAIJ >> VIENNACL,ierr) >> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > > > print*,'SETTING GPU TYPES' >> > > > > > > #else >> > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >> > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) >> > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! >> > > > > > > #endif >> > > > > > > call >> > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > > > else ! set matrix type sequential >> > > > > > > #ifdef GPU >> > > > > > > call DMSetMatType(daDummy,MATSEQAIJ >> VIENNACL,ierr) >> > > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >> > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >> > > > > > > print*,'SETTING GPU TYPES' >> > > > > > > #else >> > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >> > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >> > > > > > > call MatSetType(A,MATSEQAIJ,ierr) >> > > > > > > #endif >> > > > > > > call MatSetUp(A,ierr) >> > > > > > > call >> > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >> > > > > > > >> > > > > > > do k=zstart,zend-1 >> > > > > > > do j=ystart,yend-1 >> > > > > > > do i=xstart,xend-1 >> > > > > > > [..] >> > > > > > > call >> > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),IN >> SERT_VALUES,ierr) >> > > > > > > [..] >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > -- >> > > > > > > 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 >> > > > > > > >> > > > > > > https://www.cse.buffalo.edu/~knepley/ >> > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > -- >> > > > > > > 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 >> > > > > > > >> > > > > > > https://www.cse.buffalo.edu/~knepley/ >> > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > -- >> > > > > > > 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 >> > > > > > > >> > > > > > > https://www.cse.buffalo.edu/~knepley/ >> > > >> > > > > > > >> > > > > > >> > > > > > >> > > > > >> > > > > >> > > > >> > > > >> > > >> > > >> > > >> > > >> > > >> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 29 16:02:29 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 29 Aug 2018 21:02:29 +0000 Subject: [petsc-users] Use block Jacobi preconditioner with SNES In-Reply-To: References: <82560715-ecaa-5ca6-4153-6d3f9cb7fbc8@cc.iut.ac.ir> <13850427-A944-4A1B-93C6-8493EC48D89C@anl.gov> <871saj1pxq.fsf@jedbrown.org> <67274A15-B6AE-4EFD-B52D-D50272791BE9@mcs.anl.gov> <17e76678-3da8-d5eb-9ee8-389ad307e2bf@cc.iut.ac.ir> <7b093784-8da8-1b00-9f31-a327d86882ab@cc.iut.ac.ir> <87in3t5a0j.fsf@jedbrown.org> <82f16e58-ab8e-2ab8-eb6b-26b9bd8e820e@cc.iut.ac.ir> <87a7p558ce.fsf@jedbrown.org> Message-ID: <8028B90E-AD96-4D6D-B789-3B3FFEDDF132@mcs.anl.gov> > On Aug 29, 2018, at 3:48 PM, Ali Reza Khaz'ali wrote: > > >> Can you confirm if your code ran successfully with vpbjacobi and if the convergence history was very similar to that achieved using >> bjacobi ? > > They have a very very very small difference (which is probably due to round-off errors), they generally behave the same. My code run successfully with both of them with the same convergence history. However, vpbjacobi seems a little faster. Great, this is exactly what to expect. I will put the branch into next for testing and then it will be in the master branch and in the next release. Barry > > Many thanks, > Ali From bsmith at mcs.anl.gov Wed Aug 29 16:02:30 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 29 Aug 2018 21:02:30 +0000 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: Please send complete error message > On Aug 29, 2018, at 3:40 PM, Manuel Valera wrote: > > Yeah, no sorry, i get the same error with -pc_type bjacobi -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" > > > Thanks and let me know of any progress on this issue, > > > > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera wrote: > Awesome, thanks! > > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. wrote: > > > > On Aug 29, 2018, at 3:26 PM, Manuel Valera wrote: > > > > > > > > You may need to use just plain PCBJACOBI or PCASM for parallelism and then SAVIENNACL sequentially on each block. > > > > > > Can you elaborate a little in how to do this? do you mean i can only use viennacl in serial at the moment or this is a suggestion of a workaround on how to make it work? > > -pc_type bjacobi -sub_pc_type SAVIENNACL > > This will run in parallel and utilize the GPU for each block of the preconditioner. > > Barry > > > > > > > Thanks, > > > > > > > > > > > > > > > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera wrote: > > > > > > Hi everyone, > > > > > > Thanks for your responses, i understand communicating on this way to this level of technicality can be hard, i still think we can work ways to solve this problem though, > > > > > > I can say the following at this point: > > > > > > ? Program works without issues in any other non-gpu preconditioner, just by calling -pc_type ### . > > > ? Program works correctly with ViennaCL preconditioners with mpirun -n 1, that is on one processor. > > > ? Program breaks with every ViennaCL preconditioner when attempting any more than 1 processors. > > > ? I haven't tried other GPU preconditioners because ViennaCL gave the best performance in 1 processor before. > > > ? I have made sure the matrix type is mpiaijviennacl as it is printed right before the error log. > > > ? I am attaching what i think are the backtrace logs of the run with two cores, as i have limited experience with this kind of debugging, and i cannot make sense of what they say, please let me know if you need me to do something else. > > > > > > Current options i can think of are giving you permission to clone my model repo, or for you to guide me trough the process remotely, > > > > > > Thanks, > > > > > > .-.-.-.- > > > > > > > > > The error i get is still: > > > > > > Matrix type: mpiaijviennacl > > > Of sizes: 125 x 125 > > > Matrix type: mpiaijviennacl > > > Of sizes: 125 x 125 > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > [0]PETSC ERROR: No support for this operation for this object type > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > [1]PETSC ERROR: ------------------------------------------------------------------------ > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > > > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > > -------------------------------------------------------------------------- > > > MPI_ABORT was invoked on rank 1 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. > > > -------------------------------------------------------------------------- > > > [0]PETSC ERROR: ------------------------------------------------------------------------ > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > > > [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. > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 /home/valera/petsc/src/mat/utils/gcreate.c > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > [0]PETSC ERROR: Signal received > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file > > > [node50:32783] 1 more process has sent help message help-mpi-api.txt / mpi-abort > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > > > > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp wrote: > > > Hi Manuel, > > > > > > as Barry said, it is hard for us to provide any help without having a more complete picture of what is going on. > > > > > > The error you report seems to come from the AMG preconditioner in ViennaCL. This can have many origins. Do other preconditioners run without error? Can you run in a debugger and provide a complete backtrace? > > > > > > Thanks and best regards, > > > Karli > > > > > > > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: > > > Talked too fast, > > > > > > After fixing that problem, i tried more than one mpi processor and got the following: > > > > > > Matrix type: mpiaijviennacl > > > Of sizes: 125 x 125 > > > Matrix type: mpiaijviennacl > > > Of sizes: 125 x 125 > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > [0]PETSC ERROR: No support for this operation for this object type > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > > [1]PETSC ERROR: ------------------------------------------------------------------------ > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > > > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > > -------------------------------------------------------------------------- > > > MPI_ABORT was invoked on rank 1 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. > > > -------------------------------------------------------------------------- > > > [0]PETSC ERROR: ------------------------------------------------------------------------ > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > > > [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. > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 /home/valera/petsc/src/sys/objects/tagm.c > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 /home/valera/petsc/src/sys/objects/inherit.c > > > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/is/interface/isreg.c > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 /home/valera/petsc/src/vec/is/is/impls/general/general.c > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > [0]PETSC ERROR: Signal received > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > > > [node50:30582] 1 more process has sent help message help-mpi-api.txt / mpi-abort > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > > > > > > > > > It is currently running in 1 mpi processor + GPU but i would like to call at least 16 mpi processors + GPU to do the rest of the data management who is not part of the main laplacian on the mpi and the laplacian solution on the GPU, is this currently possible? > > > > > > Thanks for your help, > > > > > > > > > > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > wrote: > > > > > > Ok, i found the culprit and we can close this thread, > > > > > > The problem was a missing variable for setting the maximum columns, > > > which i deleted at some point without realizing. The error message > > > was too ambiguous to catch this so i had to compare with a previous > > > working version of the arguments of MatSetValues, it was evident then. > > > > > > Good news is that i can now set the values with the viennacl types too, > > > > > > Thanks for your kind help, > > > > > > Manuel > > > > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. > > > > wrote: > > > > > > > > > 1) PetscMalloc() is never valid or needed in Fortran > > > > > > 2) there is no reason to use DMSetMatrixPreallocateOnly() > > > just use DMCreateMatrix() assuming that using a DM (DMDA, > > > DMPLEX, etc) is suitable for your problem. > > > > > > At this end we are totally guessing at what you are doing > > > and so have little help we can provide. A simple, nonworking > > > code that tries to do what you would need would help us a great > > > deal in understanding that you are trying to do. > > > > > > Barry > > > > > > > > > > > > > > > > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera > > > > wrote: > > > > > > > > Matthew, PetscMalloc gives the same error, > > > > > > > > Barry, it would be very hard for me to get the code to a > > > minimum working example, i guess all i need to understand is how > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() instead > > > of MatMPIAIJSetPreallocation() as we were doing before, is there > > > a simple example who does this in Fortran? > > > > > > > > Is the PetscMalloc call needed? is 'call > > > PetscMalloc(1,row,ierr)' a valid, compilable call to > > > PetscMalloc? what other reason may there be for this error to > > > happen ? > > > > > > > > Just remembering, that trying to setup the matrix with the > > > MatAIJSetPreallocation() brings up an error to acknowledge the > > > viennacl datatypes and that's why i'm trying to make this change > > > on your recommendation, > > > > > > > > Thanks for your help, > > > > > > > > > > > > > > > > > > > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. > > > > wrote: > > > > > > > > Send your code in a way we can compile and run it; it must > > > be some simple issue that is hard to communicate in email. > > > > > > > > Barry > > > > > > > > > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera > > > > wrote: > > > > > > > > > > Hello everyone, > > > > > > > > > > I just had time to work on this again, and checked the code > > > for errors on the matrix entries, this is the exact code i was > > > using for creating the matrix without > > > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and > > > it worked that way, but trying this way i get the same 'Column > > > too large' error using any number at the column position of > > > MatSetValues, > > > > > > > > > > I have set up my code to print the column argument (n) of > > > MatSetValues and in this case is 7 (lower than 124), it still > > > gives error, even entering a specific number in the MatSetValues > > > column argument position gives the same error. > > > > > > > > > > So next i went back to ex.50 here: > > > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html > > > > > > and it has a very similar structure except the PetscMalloc1() > > > call, so i tried adding that and got: > > > > > > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined > > > reference to `petscmalloc1_' > > > > > > > > > > Any ideas on this behaviour? > > > > > > > > > > Thanks so much, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > > > > wrote: > > > > > > > > > > Column too large: col 10980 max 124 > > > > > > > > > > You need to check the code that is generating the matrix > > > entries. The matrix has 124 columns but you are attempting to > > > put a value at column 10980 > > > > > > > > > > Barry > > > > > > > > > > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera > > > > wrote: > > > > > > > > > > > > Thanks Matthew and Barry, > > > > > > > > > > > > Now my code looks like: > > > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > call MatSetFromOptions(A,ierr) > > > > > > call MatSetUp(A,ierr) > > > > > > [...] > > > > > > call > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > [...] > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > And i get a different error, now is: > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > > -------------------------------------------------------------- > > > > > > [0]PETSC ERROR: Argument out of range > > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > > > > [0]PETSC ERROR: See > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > for > > > trouble shooting. > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 > > > by valera Wed Aug 15 19:40:00 2018 > > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > > > > wrote: > > > > > > > > > > > > Should be > > > > > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > > > > > and remove the rest. You need to set the type of Mat > > > you want the DM to return BEFORE you create the matrix. > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera > > > > wrote: > > > > > > > > > > > > > > Ok thanks for clarifying that, i wasn't sure if there > > > were different types, > > > > > > > > > > > > > > Here is a stripped down version of my code, it seems > > > like the preallocation is working now since the matrix > > > population part is working without problem, but here it is for > > > illustration purposes: > > > > > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > call > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > call MatSetUp(A,ierr) > > > > > > > [...] > > > > > > > call > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > > [...] > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > > > Adding the first line there did the trick, > > > > > > > > > > > > > > Now the problem seems to be the program is not > > > recognizing the matrix as ViennaCL type when i try with more > > > than one processor, i get now: > > > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > > -------------------------------------------------------------- > > > > > > > [0]PETSC ERROR: No support for this operation for this > > > object type > > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > > > > [0]PETSC ERROR: See > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > for > > > trouble shooting. > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > > node50 by valera Wed Aug 15 14:44:22 2018 > > > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > > > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > > > > > > > When running with: > > > > > > > > > > > > > > mpirun -n 1 ./gcmLEP.GPU > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > > > > wrote: > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > > > > wrote: > > > > > > > It seems to be resumed on: I do not know how to > > > preallocate a DM Matrix correctly. > > > > > > > > > > > > > > There is only one matrix type, Mat. There are no > > > separate DM matrices. A DM can create a matrix for you > > > > > > > using DMCreateMatrix(), but that is a Mat and it is > > > preallocated correctly. I am not sure what you are doing. > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > The interesting part is that it only breaks when i need > > > to populate a GPU matrix from MPI, so kudos on that, but it > > > seems i need to do better on my code to get this setup working, > > > > > > > > > > > > > > Any help would be appreciated, > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > > > > wrote: > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > > > > wrote: > > > > > > > Thanks Matthew, > > > > > > > > > > > > > > I try to do that when calling: > > > > > > > > > > > > > > call > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > > > > > > > But i am not aware on how to do this for the DM if it > > > needs something more specific/different, > > > > > > > > > > > > > > The error says that your preallocation is wrong for the > > > values you are putting in. The DM does not control either, > > > > > > > so I do not understand your email. > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > > > > wrote: > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > > > > wrote: > > > > > > > Hello PETSc devs, > > > > > > > > > > > > > > I am running into an error when trying to use the > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs > > > for MATSEQAIJVIENNACL type in one processor. The error happens > > > when calling MatSetValues for this specific configuration. It > > > does not occur when using MPI DMMatrix types only. > > > > > > > > > > > > > > The DM properly preallocates the matrix. I am assuming > > > you do not here. > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > Any help will be appreciated, > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > My program call: > > > > > > > > > > > > > > mpirun -n 2 ./gcmLEP.GPU > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > > > > > > > [1]PETSC ERROR: --------------------- Error Message > > > -------------------------------------------------------------- > > > > > > > [1]PETSC ERROR: Argument out of range > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global > > > row/column (75, 50) into matrix > > > > > > > [1]PETSC ERROR: See > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > for > > > trouble shooting. > > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > > node50 by valera Wed Aug 15 13:10:44 2018 > > > > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > > > > My Code structure: > > > > > > > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > > > > > if (numprocs > 1) then ! set matrix type parallel > > > > > > > ! Get local size > > > > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > > > > call VecDestroy(Tmpnat,ierr) > > > > > > > ! Set matrix > > > > > > > #ifdef GPU > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > print*,'SETTING GPU TYPES' > > > > > > > #else > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > > > > > #endif > > > > > > > call > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > else ! set matrix type sequential > > > > > > > #ifdef GPU > > > > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > > > > print*,'SETTING GPU TYPES' > > > > > > > #else > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) > > > > > > > #endif > > > > > > > call MatSetUp(A,ierr) > > > > > > > call > > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > > > > > > > do k=zstart,zend-1 > > > > > > > do j=ystart,yend-1 > > > > > > > do i=xstart,xend-1 > > > > > > > [..] > > > > > > > call > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > 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 > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > 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 > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > 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 > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > From mvalera-w at sdsu.edu Wed Aug 29 16:21:30 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 29 Aug 2018 14:21:30 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: Ok, executing with: mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view I get: SETTING GPU TYPES Matrix type: mpiaijviennacl Of sizes: 125 x 125 Matrix type: mpiaijviennacl Of sizes: 125 x 125 [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: No support for this operation for this object type [0]PETSC ERROR: Currently only handles ViennaCL matrices [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 14:20:42 2018 [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c [1]PETSC ERROR: ------------------------------------------------------------------------ [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 14:20:42 2018 [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp [1]PETSC ERROR: #1 User provided function() line 0 in unknown file -------------------------------------------------------------------------- MPI_ABORT was invoked on rank 1 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. -------------------------------------------------------------------------- [0]PETSC ERROR: ------------------------------------------------------------------------ [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end [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. [0]PETSC ERROR: [0] PetscCommDuplicate line 130 /home/valera/petsc/src/sys/objects/tagm.c [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 /home/valera/petsc/src/sys/objects/inherit.c [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/is/interface/isreg.c [0]PETSC ERROR: [0] ISCreateGeneral line 658 /home/valera/petsc/src/vec/is/is/impls/general/general.c [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: Signal received [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 14:20:42 2018 [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp [0]PETSC ERROR: #3 User provided function() line 0 in unknown file [node50:77836] 1 more process has sent help message help-mpi-api.txt / mpi-abort [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. wrote: > Please send complete error message > > > > On Aug 29, 2018, at 3:40 PM, Manuel Valera wrote: > > > > Yeah, no sorry, i get the same error with -pc_type bjacobi -sub_pc_type > SAVIENNACL : "Currently only handles ViennaCL matrices" > > > > > > Thanks and let me know of any progress on this issue, > > > > > > > > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera > wrote: > > Awesome, thanks! > > > > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. > wrote: > > > > > > > On Aug 29, 2018, at 3:26 PM, Manuel Valera wrote: > > > > > > > > > > > > You may need to use just plain PCBJACOBI or PCASM for parallelism and > then SAVIENNACL sequentially on each block. > > > > > > > > > Can you elaborate a little in how to do this? do you mean i can only > use viennacl in serial at the moment or this is a suggestion of a > workaround on how to make it work? > > > > -pc_type bjacobi -sub_pc_type SAVIENNACL > > > > This will run in parallel and utilize the GPU for each block of the > preconditioner. > > > > Barry > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera > wrote: > > > > > > > > Hi everyone, > > > > > > > > Thanks for your responses, i understand communicating on this way to > this level of technicality can be hard, i still think we can work ways to > solve this problem though, > > > > > > > > I can say the following at this point: > > > > > > > > ? Program works without issues in any other non-gpu > preconditioner, just by calling -pc_type ### . > > > > ? Program works correctly with ViennaCL preconditioners with > mpirun -n 1, that is on one processor. > > > > ? Program breaks with every ViennaCL preconditioner when > attempting any more than 1 processors. > > > > ? I haven't tried other GPU preconditioners because ViennaCL > gave the best performance in 1 processor before. > > > > ? I have made sure the matrix type is mpiaijviennacl as it is > printed right before the error log. > > > > ? I am attaching what i think are the backtrace logs of the > run with two cores, as i have limited experience with this kind of > debugging, and i cannot make sense of what they say, please let me know if > you need me to do something else. > > > > > > > > Current options i can think of are giving you permission to clone my > model repo, or for you to guide me trough the process remotely, > > > > > > > > Thanks, > > > > > > > > .-.-.-.- > > > > > > > > > > > > The error i get is still: > > > > > > > > Matrix type: mpiaijviennacl > > > > > Of sizes: 125 x 125 > > > > Matrix type: mpiaijviennacl > > > > > Of sizes: 125 x 125 > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > [0]PETSC ERROR: No support for this operation for this object type > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Wed Aug 29 11:43:25 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ > ksp/interface/itfunc.c > > > > [1]PETSC ERROR: ------------------------------ > ------------------------------------------ > > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation > Violation, probably memory access out of range > > > > [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] PetscTraceBackErrorHandler line 182 > /home/valera/petsc/src/sys/error/errtrace.c > > > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/ > error/err.c > > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Wed Aug 29 11:43:25 2018 > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > > > ------------------------------------------------------------ > -------------- > > > > MPI_ABORT was invoked on rank 1 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. > > > > ------------------------------------------------------------ > -------------- > > > > [0]PETSC ERROR: ------------------------------ > ------------------------------------------ > > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or > the batch system) has told this process to end > > > > [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. > > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 > /home/valera/petsc/src/mat/utils/gcreate.c > > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ > ksp/interface/itfunc.c > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > [0]PETSC ERROR: Signal received > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Wed Aug 29 11:43:25 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file > > > > [node50:32783] 1 more process has sent help message help-mpi-api.txt > / mpi-abort > > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to > see all help / error messages > > > > > > > > > > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp > wrote: > > > > Hi Manuel, > > > > > > > > as Barry said, it is hard for us to provide any help without having > a more complete picture of what is going on. > > > > > > > > The error you report seems to come from the AMG preconditioner in > ViennaCL. This can have many origins. Do other preconditioners run without > error? Can you run in a debugger and provide a complete backtrace? > > > > > > > > Thanks and best regards, > > > > Karli > > > > > > > > > > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: > > > > Talked too fast, > > > > > > > > After fixing that problem, i tried more than one mpi processor and > got the following: > > > > > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > [0]PETSC ERROR: No support for this operation for this object type > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Tue Aug 28 16:30:02 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < > http://saviennacl.cu> > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [1]PETSC ERROR: ------------------------------ > ------------------------------------------ > > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation > Violation, probably memory access out of range > > > > [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] PetscTraceBackErrorHandler line 182 > /home/valera/petsc/src/sys/error/errtrace.c > > > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/ > error/err.c > > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< > http://saviennacl.cu> > > > > > > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Tue Aug 28 16:30:02 2018 > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > > > ------------------------------------------------------------ > -------------- > > > > MPI_ABORT was invoked on rank 1 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. > > > > ------------------------------------------------------------ > -------------- > > > > [0]PETSC ERROR: ------------------------------ > ------------------------------------------ > > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or > the batch system) has told this process to end > > > > [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. > > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 > /home/valera/petsc/src/sys/objects/tagm.c > > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 > /home/valera/petsc/src/sys/objects/inherit.c > > > > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/ > is/interface/isreg.c > > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 > /home/valera/petsc/src/vec/is/is/impls/general/general.c > > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< > http://saviennacl.cu> > > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > > > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > > > [0]PETSC ERROR: Signal received > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ > documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 > GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera > Tue Aug 28 16:30:02 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl > > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > > > > [node50:30582] 1 more process has sent help message help-mpi-api.txt > / mpi-abort > > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to > see all help / error messages > > > > > > > > > > > > > > > > It is currently running in 1 mpi processor + GPU but i would like to > call at least 16 mpi processors + GPU to do the rest of the data management > who is not part of the main laplacian on the mpi and the laplacian solution > on the GPU, is this currently possible? > > > > > > > > Thanks for your help, > > > > > > > > > > > > > > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > wrote: > > > > > > > > Ok, i found the culprit and we can close this thread, > > > > > > > > The problem was a missing variable for setting the maximum > columns, > > > > which i deleted at some point without realizing. The error > message > > > > was too ambiguous to catch this so i had to compare with a > previous > > > > working version of the arguments of MatSetValues, it was evident > then. > > > > > > > > Good news is that i can now set the values with the viennacl > types too, > > > > > > > > Thanks for your kind help, > > > > > > > > Manuel > > > > > > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > > > 1) PetscMalloc() is never valid or needed in Fortran > > > > > > > > 2) there is no reason to use > DMSetMatrixPreallocateOnly() > > > > just use DMCreateMatrix() assuming that using a DM (DMDA, > > > > DMPLEX, etc) is suitable for your problem. > > > > > > > > At this end we are totally guessing at what you are > doing > > > > and so have little help we can provide. A simple, nonworking > > > > code that tries to do what you would need would help us a > great > > > > deal in understanding that you are trying to do. > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > Matthew, PetscMalloc gives the same error, > > > > > > > > > > Barry, it would be very hard for me to get the code to a > > > > minimum working example, i guess all i need to understand is > how > > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() > instead > > > > of MatMPIAIJSetPreallocation() as we were doing before, is > there > > > > a simple example who does this in Fortran? > > > > > > > > > > Is the PetscMalloc call needed? is 'call > > > > PetscMalloc(1,row,ierr)' a valid, compilable call to > > > > PetscMalloc? what other reason may there be for this error to > > > > happen ? > > > > > > > > > > Just remembering, that trying to setup the matrix with the > > > > MatAIJSetPreallocation() brings up an error to acknowledge > the > > > > viennacl datatypes and that's why i'm trying to make this > change > > > > on your recommendation, > > > > > > > > > > Thanks for your help, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > Send your code in a way we can compile and run it; it > must > > > > be some simple issue that is hard to communicate in email. > > > > > > > > > > Barry > > > > > > > > > > > > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > > > Hello everyone, > > > > > > > > > > > > I just had time to work on this again, and checked the > code > > > > for errors on the matrix entries, this is the exact code i > was > > > > using for creating the matrix without > > > > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation > and > > > > it worked that way, but trying this way i get the same > 'Column > > > > too large' error using any number at the column position of > > > > MatSetValues, > > > > > > > > > > > > I have set up my code to print the column argument (n) > of > > > > MatSetValues and in this case is 7 (lower than 124), it still > > > > gives error, even entering a specific number in the > MatSetValues > > > > column argument position gives the same error. > > > > > > > > > > > > So next i went back to ex.50 here: > > > > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/ > tutorials/ex50.c.html > > > > tutorials/ex50.c.html> > > > > and it has a very similar structure except the PetscMalloc1() > > > > call, so i tried adding that and got: > > > > > > > > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: > undefined > > > > reference to `petscmalloc1_' > > > > > > > > > > > > Any ideas on this behaviour? > > > > > > > > > > > > Thanks so much, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > > > Column too large: col 10980 max 124 > > > > > > > > > > > > You need to check the code that is generating the > matrix > > > > entries. The matrix has 124 columns but you are attempting to > > > > put a value at column 10980 > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > > > > > Thanks Matthew and Barry, > > > > > > > > > > > > > > Now my code looks like: > > > > > > > > > > > > > > call DMSetMatrixPreallocateOnly( > daDummy,PETSC_TRUE,ierr) > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > call MatSetUp(A,ierr) > > > > > > > [...] > > > > > > > call > > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), > INSERT_VALUES,ierr) > > > > > > > [...] > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > > > And i get a different error, now is: > > > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > > > ------------------------------------------------------------ > -- > > > > > > > [0]PETSC ERROR: Argument out of range > > > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > > > > > [0]PETSC ERROR: See > > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > > for > > > > trouble shooting. > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > node50 > > > > by valera Wed Aug 15 19:40:00 2018 > > > > > > > [0]PETSC ERROR: Configure options > PETSC_ARCH=cuda-debug > > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > > > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > > > > > Should be > > > > > > > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > > > > > > > and remove the rest. You need to set the type of Mat > > > > you want the DM to return BEFORE you create the matrix. > > > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > > > > > > > Ok thanks for clarifying that, i wasn't sure if > there > > > > were different types, > > > > > > > > > > > > > > > > Here is a stripped down version of my code, it seems > > > > like the preallocation is working now since the matrix > > > > population part is working without problem, but here it is > for > > > > illustration purposes: > > > > > > > > > > > > > > > > call DMSetMatrixPreallocateOnly( > daDummy,PETSC_TRUE,ierr) > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > > call > > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > > > call MatSetUp(A,ierr) > > > > > > > > [...] > > > > > > > > call > > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), > INSERT_VALUES,ierr) > > > > > > > > [...] > > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > > > > > Adding the first line there did the trick, > > > > > > > > > > > > > > > > Now the problem seems to be the program is not > > > > recognizing the matrix as ViennaCL type when i try with more > > > > than one processor, i get now: > > > > > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > > > ------------------------------------------------------------ > -- > > > > > > > > [0]PETSC ERROR: No support for this operation for > this > > > > object type > > > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL > matrices > > > > > > > > [0]PETSC ERROR: See > > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > > for > > > > trouble shooting. > > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > > > node50 by valera Wed Aug 15 14:44:22 2018 > > > > > > > > [0]PETSC ERROR: Configure options > PETSC_ARCH=cuda-debug > > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennac > l.cu > > > > > > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > > > > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > > > > > > > > > When running with: > > > > > > > > > > > > > > > > mpirun -n 1 ./gcmLEP.GPU > > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > > > > > wrote: > > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > > > > > wrote: > > > > > > > > It seems to be resumed on: I do not know how to > > > > preallocate a DM Matrix correctly. > > > > > > > > > > > > > > > > There is only one matrix type, Mat. There are no > > > > separate DM matrices. A DM can create a matrix for you > > > > > > > > using DMCreateMatrix(), but that is a Mat and it is > > > > preallocated correctly. I am not sure what you are doing. > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > > > The interesting part is that it only breaks when i > need > > > > to populate a GPU matrix from MPI, so kudos on that, but it > > > > seems i need to do better on my code to get this setup > working, > > > > > > > > > > > > > > > > Any help would be appreciated, > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > > > > > wrote: > > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > > > > > wrote: > > > > > > > > Thanks Matthew, > > > > > > > > > > > > > > > > I try to do that when calling: > > > > > > > > > > > > > > > > call > > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > > > > > > > > > > > But i am not aware on how to do this for the DM if > it > > > > needs something more specific/different, > > > > > > > > > > > > > > > > The error says that your preallocation is wrong for > the > > > > values you are putting in. The DM does not control either, > > > > > > > > so I do not understand your email. > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > > > > > wrote: > > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > > > > > wrote: > > > > > > > > Hello PETSc devs, > > > > > > > > > > > > > > > > I am running into an error when trying to use the > > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code > runs > > > > for MATSEQAIJVIENNACL type in one processor. The error > happens > > > > when calling MatSetValues for this specific configuration. It > > > > does not occur when using MPI DMMatrix types only. > > > > > > > > > > > > > > > > The DM properly preallocates the matrix. I am > assuming > > > > you do not here. > > > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > > > Any help will be appreciated, > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > My program call: > > > > > > > > > > > > > > > > mpirun -n 2 ./gcmLEP.GPU > > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > > > > > > > > > [1]PETSC ERROR: --------------------- Error Message > > > > ------------------------------------------------------------ > -- > > > > > > > > [1]PETSC ERROR: Argument out of range > > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global > > > > row/column (75, 50) into matrix > > > > > > > > [1]PETSC ERROR: See > > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > > for > > > > trouble shooting. > > > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: > > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > > > node50 by valera Wed Aug 15 13:10:44 2018 > > > > > > > > [1]PETSC ERROR: Configure options > PETSC_ARCH=cuda-debug > > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > > > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > > > > > > > My Code structure: > > > > > > > > > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, > ierr) > > > > > > > > if (numprocs > 1) then ! set matrix type parallel > > > > > > > > ! Get local size > > > > > > > > call DMDACreateNaturalVector( > daDummy,Tmpnat,ierr) > > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > > > > > call VecDestroy(Tmpnat,ierr) > > > > > > > > ! Set matrix > > > > > > > > #ifdef GPU > > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > > > > > > call DMSetMatType(daDummy, > MATMPIAIJVIENNACL,ierr) > > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > > print*,'SETTING GPU TYPES' > > > > > > > > #else > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > > > > > > #endif > > > > > > > > call > > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, > PETSC_NULL_INTEGER,ierr) > > > > > > > > else ! set matrix type sequential > > > > > > > > #ifdef GPU > > > > > > > > call DMSetMatType(daDummy, > MATSEQAIJVIENNACL,ierr) > > > > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > > > > > print*,'SETTING GPU TYPES' > > > > > > > > #else > > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) > > > > > > > > #endif > > > > > > > > call MatSetUp(A,ierr) > > > > > > > > call > > > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > > > > > > > > > do k=zstart,zend-1 > > > > > > > > do j=ystart,yend-1 > > > > > > > > do i=xstart,xend-1 > > > > > > > > [..] > > > > > > > > call > > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), > INSERT_VALUES,ierr) > > > > > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > > 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 > > > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > > 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 > > > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > > 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 > > > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mvalera-w at sdsu.edu Wed Aug 29 16:49:13 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 29 Aug 2018 14:49:13 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: Update: I made it work like you suggested Barry, i had to comment the code line to set up the pc_type saviennacl, that way i am getting as ksp_view: KSP Object: 2 MPI processes type: cg maximum iterations=10000, initial guess is zero tolerances: relative=1e-07, absolute=1e-50, divergence=10000. left preconditioning using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: bjacobi number of blocks = 2 Local solve is same for all blocks, in the following KSP and PC objects: KSP Object: (sub_) 1 MPI processes type: preonly maximum iterations=10000, initial guess is zero tolerances: relative=1e-05, absolute=1e-50, divergence=10000. left preconditioning using NONE norm type for convergence test PC Object: (sub_) 1 MPI processes type: ilu out-of-place factorization 0 levels of fill tolerance for zero pivot 2.22045e-14 matrix ordering: natural factor fill ratio given 1., needed 1. Factored matrix follows: Mat Object: 1 MPI processes type: seqaij rows=75, cols=75 package used to perform factorization: petsc total: nonzeros=927, allocated nonzeros=927 total number of mallocs used during MatSetValues calls =0 not using I-node routines linear system matrix = precond matrix: Mat Object: 1 MPI processes type: seqaijviennacl rows=75, cols=75 total: nonzeros=927, allocated nonzeros=1335 total number of mallocs used during MatSetValues calls =84 not using I-node routines linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaijviennacl rows=125, cols=125 total: nonzeros=1685, allocated nonzeros=2885 total number of mallocs used during MatSetValues calls =184 has attached near null space Press_Max: 1.9995807630564922E-004 This is what we want, right? Still if i try using pc_type saviennacl directly it breaks, Thanks for your help i'll try my speedup like this, On Wed, Aug 29, 2018 at 2:21 PM, Manuel Valera wrote: > Ok, executing with: > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ > jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view > > > I get: > > > SETTING GPU TYPES > Matrix type: mpiaijviennacl > > Of sizes: 125 x 125 > Matrix type: mpiaijviennacl > > Of sizes: 125 x 125 > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Currently only handles ViennaCL matrices > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT > Date: 2018-08-29 12:42:36 -0600 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 29 14:20:42 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc > --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl --download-cusp > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ > interface/precon.c > [1]PETSC ERROR: ------------------------------ > ------------------------------------------ > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, > probably memory access out of range > [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] PetscTraceBackErrorHandler line 182 > /home/valera/petsc/src/sys/error/errtrace.c > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/ > error/err.c > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.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 Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT > Date: 2018-08-29 12:42:36 -0600 > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 29 14:20:42 2018 > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc > --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl --download-cusp > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > -------------------------------------------------------------------------- > MPI_ABORT was invoked on rank 1 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. > -------------------------------------------------------------------------- > [0]PETSC ERROR: ------------------------------ > ------------------------------------------ > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the > batch system) has told this process to end > [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. > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 /home/valera/petsc/src/sys/ > objects/tagm.c > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 > /home/valera/petsc/src/sys/objects/inherit.c > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/ > is/interface/isreg.c > [0]PETSC ERROR: [0] ISCreateGeneral line 658 /home/valera/petsc/src/vec/is/ > is/impls/general/general.c > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ > interface/precon.c > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: Signal received > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT > Date: 2018-08-29 12:42:36 -0600 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed > Aug 29 14:20:42 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc > --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 > --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 > --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 > --download-viennacl --download-cusp > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > [node50:77836] 1 more process has sent help message help-mpi-api.txt / > mpi-abort > [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to see > all help / error messages > > > > On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. > wrote: > >> Please send complete error message >> >> >> > On Aug 29, 2018, at 3:40 PM, Manuel Valera wrote: >> > >> > Yeah, no sorry, i get the same error with -pc_type bjacobi >> -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" >> > >> > >> > Thanks and let me know of any progress on this issue, >> > >> > >> > >> > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera >> wrote: >> > Awesome, thanks! >> > >> > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. >> wrote: >> > >> > >> > > On Aug 29, 2018, at 3:26 PM, Manuel Valera >> wrote: >> > > >> > > >> > > >> > > You may need to use just plain PCBJACOBI or PCASM for parallelism >> and then SAVIENNACL sequentially on each block. >> > > >> > > >> > > Can you elaborate a little in how to do this? do you mean i can only >> use viennacl in serial at the moment or this is a suggestion of a >> workaround on how to make it work? >> > >> > -pc_type bjacobi -sub_pc_type SAVIENNACL >> > >> > This will run in parallel and utilize the GPU for each block of the >> preconditioner. >> > >> > Barry >> > >> > > >> > > >> > > Thanks, >> > > >> > > >> > > >> > > >> > > >> > > >> > > >> > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera >> wrote: >> > > > >> > > > Hi everyone, >> > > > >> > > > Thanks for your responses, i understand communicating on this way >> to this level of technicality can be hard, i still think we can work ways >> to solve this problem though, >> > > > >> > > > I can say the following at this point: >> > > > >> > > > ? Program works without issues in any other non-gpu >> preconditioner, just by calling -pc_type ### . >> > > > ? Program works correctly with ViennaCL preconditioners with >> mpirun -n 1, that is on one processor. >> > > > ? Program breaks with every ViennaCL preconditioner when >> attempting any more than 1 processors. >> > > > ? I haven't tried other GPU preconditioners because ViennaCL >> gave the best performance in 1 processor before. >> > > > ? I have made sure the matrix type is mpiaijviennacl as it is >> printed right before the error log. >> > > > ? I am attaching what i think are the backtrace logs of the >> run with two cores, as i have limited experience with this kind of >> debugging, and i cannot make sense of what they say, please let me know if >> you need me to do something else. >> > > > >> > > > Current options i can think of are giving you permission to clone >> my model repo, or for you to guide me trough the process remotely, >> > > > >> > > > Thanks, >> > > > >> > > > .-.-.-.- >> > > > >> > > > >> > > > The error i get is still: >> > > > >> > > > Matrix type: mpiaijviennacl >> >> > > > Of sizes: 125 x 125 >> > > > Matrix type: mpiaijviennacl >> >> > > > Of sizes: 125 x 125 >> > > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > [0]PETSC ERROR: No support for this operation for this object type >> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > > [0]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Wed Aug 29 11:43:25 2018 >> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >> /home/valera/petsc/src/ksp/pc/interface/precon.c >> > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >> > > > [1]PETSC ERROR: ------------------------------ >> ------------------------------------------ >> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >> Violation, probably memory access out of range >> > > > [1]PETSC ERROR: Try option -start_in_debugger or >> -on_error_attach_debugger >> > > > [1]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >> ocumentation/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] PetscTraceBackErrorHandler line 182 >> /home/valera/petsc/src/sys/error/errtrace.c >> > > > [1]PETSC ERROR: [1] PetscError line 352 >> /home/valera/petsc/src/sys/error/err.c >> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> > > > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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/d >> ocumentation/faq.html for trouble shooting. >> > > > [1]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Wed Aug 29 11:43:25 2018 >> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >> > > > ------------------------------------------------------------ >> -------------- >> > > > MPI_ABORT was invoked on rank 1 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. >> > > > ------------------------------------------------------------ >> -------------- >> > > > [0]PETSC ERROR: ------------------------------ >> ------------------------------------------ >> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or >> the batch system) has told this process to end >> > > > [0]PETSC ERROR: Try option -start_in_debugger or >> -on_error_attach_debugger >> > > > [0]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >> ocumentation/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. >> > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 >> /home/valera/petsc/src/mat/utils/gcreate.c >> > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> > > > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ksp >> /interface/itfunc.c >> > > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > [0]PETSC ERROR: Signal received >> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > > [0]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Wed Aug 29 11:43:25 2018 >> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file >> > > > [node50:32783] 1 more process has sent help message >> help-mpi-api.txt / mpi-abort >> > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to >> see all help / error messages >> > > > >> > > > >> > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp >> wrote: >> > > > Hi Manuel, >> > > > >> > > > as Barry said, it is hard for us to provide any help without having >> a more complete picture of what is going on. >> > > > >> > > > The error you report seems to come from the AMG preconditioner in >> ViennaCL. This can have many origins. Do other preconditioners run without >> error? Can you run in a debugger and provide a complete backtrace? >> > > > >> > > > Thanks and best regards, >> > > > Karli >> > > > >> > > > >> > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: >> > > > Talked too fast, >> > > > >> > > > After fixing that problem, i tried more than one mpi processor and >> got the following: >> > > > >> > > > Matrix type: mpiaijviennacl >> > > > Of sizes: 125 x 125 >> > > > Matrix type: mpiaijviennacl >> > > > Of sizes: 125 x 125 >> > > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > [0]PETSC ERROR: No support for this operation for this object type >> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > > [0]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Tue Aug 28 16:30:02 2018 >> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >> http://saviennacl.cu> >> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >> /home/valera/petsc/src/ksp/pc/interface/precon.c >> > > > [1]PETSC ERROR: ------------------------------ >> ------------------------------------------ >> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >> Violation, probably memory access out of range >> > > > [1]PETSC ERROR: Try option -start_in_debugger or >> -on_error_attach_debugger >> > > > [1]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >> ocumentation/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] PetscTraceBackErrorHandler line 182 >> /home/valera/petsc/src/sys/error/errtrace.c >> > > > [1]PETSC ERROR: [1] PetscError line 352 >> /home/valera/petsc/src/sys/error/err.c >> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >> http://saviennacl.cu> >> > > > >> > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> > > > [1]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > [1]PETSC ERROR: Signal received >> > > > [1]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > > [1]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Tue Aug 28 16:30:02 2018 >> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >> > > > ------------------------------------------------------------ >> -------------- >> > > > MPI_ABORT was invoked on rank 1 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. >> > > > ------------------------------------------------------------ >> -------------- >> > > > [0]PETSC ERROR: ------------------------------ >> ------------------------------------------ >> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or >> the batch system) has told this process to end >> > > > [0]PETSC ERROR: Try option -start_in_debugger or >> -on_error_attach_debugger >> > > > [0]PETSC ERROR: or see http://www.mcs.anl.gov/petsc/d >> ocumentation/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. >> > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >> /home/valera/petsc/src/sys/objects/tagm.c >> > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >> /home/valera/petsc/src/sys/objects/inherit.c >> > > > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/ >> is/interface/isreg.c >> > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 >> /home/valera/petsc/src/vec/is/is/impls/general/general.c >> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >> http://saviennacl.cu> >> > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >> interface/precon.c >> > > > [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> > > > [0]PETSC ERROR: Signal received >> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/d >> ocumentation/faq.html for trouble shooting. >> > > > [0]PETSC ERROR: Petsc Development GIT revision: >> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >> Tue Aug 28 16:30:02 2018 >> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl >> > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >> > > > [node50:30582] 1 more process has sent help message >> help-mpi-api.txt / mpi-abort >> > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to >> see all help / error messages >> > > > >> > > > >> > > > >> > > > It is currently running in 1 mpi processor + GPU but i would like >> to call at least 16 mpi processors + GPU to do the rest of the data >> management who is not part of the main laplacian on the mpi and the >> laplacian solution on the GPU, is this currently possible? >> > > > >> > > > Thanks for your help, >> > > > >> > > > >> > > > >> > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > > wrote: >> > > > >> > > > Ok, i found the culprit and we can close this thread, >> > > > >> > > > The problem was a missing variable for setting the maximum >> columns, >> > > > which i deleted at some point without realizing. The error >> message >> > > > was too ambiguous to catch this so i had to compare with a >> previous >> > > > working version of the arguments of MatSetValues, it was >> evident then. >> > > > >> > > > Good news is that i can now set the values with the viennacl >> types too, >> > > > >> > > > Thanks for your kind help, >> > > > >> > > > Manuel >> > > > >> > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >> > > > > wrote: >> > > > >> > > > >> > > > 1) PetscMalloc() is never valid or needed in Fortran >> > > > >> > > > 2) there is no reason to use >> DMSetMatrixPreallocateOnly() >> > > > just use DMCreateMatrix() assuming that using a DM (DMDA, >> > > > DMPLEX, etc) is suitable for your problem. >> > > > >> > > > At this end we are totally guessing at what you are >> doing >> > > > and so have little help we can provide. A simple, >> nonworking >> > > > code that tries to do what you would need would help us a >> great >> > > > deal in understanding that you are trying to do. >> > > > >> > > > Barry >> > > > >> > > > >> > > > >> > > > >> > > > >> > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera >> > > > > wrote: >> > > > > >> > > > > Matthew, PetscMalloc gives the same error, >> > > > > >> > > > > Barry, it would be very hard for me to get the code to a >> > > > minimum working example, i guess all i need to understand >> is how >> > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() >> instead >> > > > of MatMPIAIJSetPreallocation() as we were doing before, is >> there >> > > > a simple example who does this in Fortran? >> > > > > >> > > > > Is the PetscMalloc call needed? is 'call >> > > > PetscMalloc(1,row,ierr)' a valid, compilable call to >> > > > PetscMalloc? what other reason may there be for this error >> to >> > > > happen ? >> > > > > >> > > > > Just remembering, that trying to setup the matrix with >> the >> > > > MatAIJSetPreallocation() brings up an error to acknowledge >> the >> > > > viennacl datatypes and that's why i'm trying to make this >> change >> > > > on your recommendation, >> > > > > >> > > > > Thanks for your help, >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > >> > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >> > > > > wrote: >> > > > > >> > > > > Send your code in a way we can compile and run it; it >> must >> > > > be some simple issue that is hard to communicate in email. >> > > > > >> > > > > Barry >> > > > > >> > > > > >> > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >> > > > > wrote: >> > > > > > >> > > > > > Hello everyone, >> > > > > > >> > > > > > I just had time to work on this again, and checked the >> code >> > > > for errors on the matrix entries, this is the exact code i >> was >> > > > using for creating the matrix without >> > > > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation >> and >> > > > it worked that way, but trying this way i get the same >> 'Column >> > > > too large' error using any number at the column position of >> > > > MatSetValues, >> > > > > > >> > > > > > I have set up my code to print the column argument (n) >> of >> > > > MatSetValues and in this case is 7 (lower than 124), it >> still >> > > > gives error, even entering a specific number in the >> MatSetValues >> > > > column argument position gives the same error. >> > > > > > >> > > > > > So next i went back to ex.50 here: >> > > > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/ >> tutorials/ex50.c.html >> > > > > examples/tutorials/ex50.c.html> >> > > > and it has a very similar structure except the >> PetscMalloc1() >> > > > call, so i tried adding that and got: >> > > > > > >> > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: >> undefined >> > > > reference to `petscmalloc1_' >> > > > > > >> > > > > > Any ideas on this behaviour? >> > > > > > >> > > > > > Thanks so much, >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > >> > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >> > > > > wrote: >> > > > > > >> > > > > > Column too large: col 10980 max 124 >> > > > > > >> > > > > > You need to check the code that is generating the >> matrix >> > > > entries. The matrix has 124 columns but you are attempting >> to >> > > > put a value at column 10980 >> > > > > > >> > > > > > Barry >> > > > > > >> > > > > > >> > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >> > > > > wrote: >> > > > > > > >> > > > > > > Thanks Matthew and Barry, >> > > > > > > >> > > > > > > Now my code looks like: >> > > > > > > >> > > > > > > call DMSetMatrixPreallocateOnly(daD >> ummy,PETSC_TRUE,ierr) >> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > > > call MatSetFromOptions(A,ierr) >> > > > > > > call MatSetUp(A,ierr) >> > > > > > > [...] >> > > > > > > call >> > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),IN >> SERT_VALUES,ierr) >> > > > > > > [...] >> > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > > > >> > > > > > > And i get a different error, now is: >> > > > > > > >> > > > > > > [0]PETSC ERROR: --------------------- Error Message >> > > > ----------------------------------------------------------- >> --- >> > > > > > > [0]PETSC ERROR: Argument out of range >> > > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 >> > > > > > > [0]PETSC ERROR: See >> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >> > > > for >> > > > trouble shooting. >> > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >> node50 >> > > > by valera Wed Aug 15 19:40:00 2018 >> > > > > > > [0]PETSC ERROR: Configure options >> PETSC_ARCH=cuda-debug >> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in >> > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c >> > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >> > > > /home/valera/petsc/src/mat/interface/matrix.c >> > > > > > > >> > > > > > > >> > > > > > > Thanks again, >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. >> > > > > wrote: >> > > > > > > >> > > > > > > Should be >> > > > > > > >> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > > > >> > > > > > > and remove the rest. You need to set the type of >> Mat >> > > > you want the DM to return BEFORE you create the matrix. >> > > > > > > >> > > > > > > Barry >> > > > > > > >> > > > > > > >> > > > > > > >> > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >> > > > > wrote: >> > > > > > > > >> > > > > > > > Ok thanks for clarifying that, i wasn't sure if >> there >> > > > were different types, >> > > > > > > > >> > > > > > > > Here is a stripped down version of my code, it >> seems >> > > > like the preallocation is working now since the matrix >> > > > population part is working without problem, but here it is >> for >> > > > illustration purposes: >> > > > > > > > >> > > > > > > > call DMSetMatrixPreallocateOnly(daD >> ummy,PETSC_TRUE,ierr) >> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > > > > call MatSetFromOptions(A,ierr) >> > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >> > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > > > > call >> > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > > > > call MatSetUp(A,ierr) >> > > > > > > > [...] >> > > > > > > > call >> > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),IN >> SERT_VALUES,ierr) >> > > > > > > > [...] >> > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >> > > > > > > > >> > > > > > > > Adding the first line there did the trick, >> > > > > > > > >> > > > > > > > Now the problem seems to be the program is not >> > > > recognizing the matrix as ViennaCL type when i try with more >> > > > than one processor, i get now: >> > > > > > > > >> > > > > > > > [0]PETSC ERROR: --------------------- Error Message >> > > > ----------------------------------------------------------- >> --- >> > > > > > > > [0]PETSC ERROR: No support for this operation for >> this >> > > > object type >> > > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL >> matrices >> > > > > > > > [0]PETSC ERROR: See >> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >> > > > for >> > > > trouble shooting. >> > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >> > > > node50 by valera Wed Aug 15 14:44:22 2018 >> > > > > > > > [0]PETSC ERROR: Configure options >> PETSC_ARCH=cuda-debug >> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/savien >> nacl.cu >> > > > >> > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >> > > > /home/valera/petsc/src/ksp/pc/interface/precon.c >> > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >> > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >> > > > > > > > >> > > > > > > > When running with: >> > > > > > > > >> > > > > > > > mpirun -n 1 ./gcmLEP.GPU >> > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl >> > > > -pc_type saviennacl -log_view >> > > > > > > > >> > > > > > > > >> > > > > > > > Thanks, >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley >> > > > > wrote: >> > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >> > > > > wrote: >> > > > > > > > It seems to be resumed on: I do not know how to >> > > > preallocate a DM Matrix correctly. >> > > > > > > > >> > > > > > > > There is only one matrix type, Mat. There are no >> > > > separate DM matrices. A DM can create a matrix for you >> > > > > > > > using DMCreateMatrix(), but that is a Mat and it is >> > > > preallocated correctly. I am not sure what you are doing. >> > > > > > > > >> > > > > > > > Thanks, >> > > > > > > > >> > > > > > > > Matt >> > > > > > > > >> > > > > > > > The interesting part is that it only breaks when i >> need >> > > > to populate a GPU matrix from MPI, so kudos on that, but it >> > > > seems i need to do better on my code to get this setup >> working, >> > > > > > > > >> > > > > > > > Any help would be appreciated, >> > > > > > > > >> > > > > > > > Thanks, >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >> > > > > wrote: >> > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >> > > > > wrote: >> > > > > > > > Thanks Matthew, >> > > > > > > > >> > > > > > > > I try to do that when calling: >> > > > > > > > >> > > > > > > > call >> > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > > > > >> > > > > > > > But i am not aware on how to do this for the DM if >> it >> > > > needs something more specific/different, >> > > > > > > > >> > > > > > > > The error says that your preallocation is wrong >> for the >> > > > values you are putting in. The DM does not control either, >> > > > > > > > so I do not understand your email. >> > > > > > > > >> > > > > > > > Thanks, >> > > > > > > > >> > > > > > > > Matt >> > > > > > > > >> > > > > > > > Thanks, >> > > > > > > > >> > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >> > > > > wrote: >> > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >> > > > > wrote: >> > > > > > > > Hello PETSc devs, >> > > > > > > > >> > > > > > > > I am running into an error when trying to use the >> > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code >> runs >> > > > for MATSEQAIJVIENNACL type in one processor. The error >> happens >> > > > when calling MatSetValues for this specific configuration. >> It >> > > > does not occur when using MPI DMMatrix types only. >> > > > > > > > >> > > > > > > > The DM properly preallocates the matrix. I am >> assuming >> > > > you do not here. >> > > > > > > > >> > > > > > > > Matt >> > > > > > > > >> > > > > > > > Any help will be appreciated, >> > > > > > > > >> > > > > > > > Thanks, >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > My program call: >> > > > > > > > >> > > > > > > > mpirun -n 2 ./gcmLEP.GPU >> > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl >> > > > -pc_type saviennacl -log_view >> > > > > > > > >> > > > > > > > >> > > > > > > > The error (repeats after each MatSetValues call): >> > > > > > > > >> > > > > > > > [1]PETSC ERROR: --------------------- Error Message >> > > > ----------------------------------------------------------- >> --- >> > > > > > > > [1]PETSC ERROR: Argument out of range >> > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global >> > > > row/column (75, 50) into matrix >> > > > > > > > [1]PETSC ERROR: See >> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >> > > > for >> > > > trouble shooting. >> > > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: >> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >> > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >> > > > node50 by valera Wed Aug 15 13:10:44 2018 >> > > > > > > > [1]PETSC ERROR: Configure options >> PETSC_ARCH=cuda-debug >> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >> > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 >> in >> > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >> > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >> > > > /home/valera/petsc/src/mat/interface/matrix.c >> > > > > > > > >> > > > > > > > >> > > > > > > > My Code structure: >> > > > > > > > >> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >> > > > > > > > call MatSetFromOptions(A,ierr) >> > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, >> ierr) >> > > > > > > > if (numprocs > 1) then ! set matrix type parallel >> > > > > > > > ! Get local size >> > > > > > > > call DMDACreateNaturalVector(daDumm >> y,Tmpnat,ierr) >> > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) >> > > > > > > > call VecDestroy(Tmpnat,ierr) >> > > > > > > > ! Set matrix >> > > > > > > > #ifdef GPU >> > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >> > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ >> VIENNACL,ierr) >> > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >> > > > > > > > print*,'SETTING GPU TYPES' >> > > > > > > > #else >> > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >> > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) >> > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! >> > > > > > > > #endif >> > > > > > > > call >> > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_ >> NULL_INTEGER,ierr) >> > > > > > > > else ! set matrix type >> sequential >> > > > > > > > #ifdef GPU >> > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ >> VIENNACL,ierr) >> > > > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >> > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >> > > > > > > > print*,'SETTING GPU TYPES' >> > > > > > > > #else >> > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >> > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >> > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) >> > > > > > > > #endif >> > > > > > > > call MatSetUp(A,ierr) >> > > > > > > > call >> > > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >> > > > > > > > >> > > > > > > > do k=zstart,zend-1 >> > > > > > > > do j=ystart,yend-1 >> > > > > > > > do i=xstart,xend-1 >> > > > > > > > [..] >> > > > > > > > call >> > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),IN >> SERT_VALUES,ierr) >> > > > > > > > [..] >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > -- >> > > > > > > > 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 >> > > > > > > > >> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >> > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > -- >> > > > > > > > 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 >> > > > > > > > >> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >> > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > >> > > > > > > > -- >> > > > > > > > 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 >> > > > > > > > >> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >> > > > >> > > > > > > > >> > > > > > > >> > > > > > > >> > > > > > >> > > > > > >> > > > > >> > > > > >> > > > >> > > > >> > > > >> > > > >> > > > >> > >> > >> > >> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Aug 29 17:05:22 2018 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 29 Aug 2018 18:05:22 -0400 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: On Wed, Aug 29, 2018 at 5:49 PM Manuel Valera wrote: > Update: > > I made it work like you suggested Barry, i had to comment the code line to > set up the pc_type saviennacl, that way i am getting as ksp_view: > > KSP Object: 2 MPI processes > type: cg > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-07, absolute=1e-50, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: 2 MPI processes > type: bjacobi > number of blocks = 2 > Local solve is same for all blocks, in the following KSP and PC > objects: > KSP Object: (sub_) 1 MPI processes > type: preonly > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > left preconditioning > using NONE norm type for convergence test > PC Object: (sub_) 1 MPI processes > type: ilu > out-of-place factorization > 0 levels of fill > tolerance for zero pivot 2.22045e-14 > matrix ordering: natural > factor fill ratio given 1., needed 1. > Factored matrix follows: > Mat Object: 1 MPI processes > type: seqaij > rows=75, cols=75 > package used to perform factorization: petsc > total: nonzeros=927, allocated nonzeros=927 > total number of mallocs used during MatSetValues calls =0 > not using I-node routines > linear system matrix = precond matrix: > Mat Object: 1 MPI processes > type: seqaijviennacl > rows=75, cols=75 > total: nonzeros=927, allocated nonzeros=1335 > total number of mallocs used during MatSetValues calls =84 > not using I-node routines > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaijviennacl > rows=125, cols=125 > total: nonzeros=1685, allocated nonzeros=2885 > total number of mallocs used during MatSetValues calls =184 > has attached near null space > Press_Max: 1.9995807630564922E-004 > > > This is what we want, right? > > Still if i try using pc_type saviennacl directly it breaks, > You are missing the point of the error message. We do not support SAVIENNACL on parallel matrices (MPIAIJ). We do support it on serial matrices (SEQAIJ). When you are setting in directly, you are applying it to a parallel matrix. If you use Block-Jacobi, you are applying it to each submatrix, and those submatrices are all serial. Thanks, Matt > Thanks for your help i'll try my speedup like this, > > > > > > On Wed, Aug 29, 2018 at 2:21 PM, Manuel Valera wrote: > >> Ok, executing with: >> >> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >> jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view >> >> >> I get: >> >> >> SETTING GPU TYPES >> Matrix type: mpiaijviennacl >> >> Of sizes: 125 x 125 >> Matrix type: mpiaijviennacl >> >> Of sizes: 125 x 125 >> [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> [0]PETSC ERROR: No support for this operation for this object type >> [0]PETSC ERROR: Currently only handles ViennaCL matrices >> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT >> Date: 2018-08-29 12:42:36 -0600 >> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >> Aug 29 14:20:42 2018 >> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc >> --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl --download-cusp >> [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> [0]PETSC ERROR: #2 PCSetUp() line 932 in >> /home/valera/petsc/src/ksp/pc/interface/precon.c >> [1]PETSC ERROR: >> ------------------------------------------------------------------------ >> [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, >> probably memory access out of range >> [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] PetscTraceBackErrorHandler line 182 >> /home/valera/petsc/src/sys/error/errtrace.c >> [1]PETSC ERROR: [1] PetscError line 352 >> /home/valera/petsc/src/sys/error/err.c >> [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> [1]PETSC ERROR: [1] PCSetUp line 894 >> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT >> Date: 2018-08-29 12:42:36 -0600 >> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >> Aug 29 14:20:42 2018 >> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc >> --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl --download-cusp >> [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >> -------------------------------------------------------------------------- >> MPI_ABORT was invoked on rank 1 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. >> -------------------------------------------------------------------------- >> [0]PETSC ERROR: >> ------------------------------------------------------------------------ >> [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the >> batch system) has told this process to end >> [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. >> [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >> /home/valera/petsc/src/sys/objects/tagm.c >> [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 >> /home/valera/petsc/src/sys/objects/inherit.c >> [0]PETSC ERROR: [0] ISCreate line 35 >> /home/valera/petsc/src/vec/is/is/interface/isreg.c >> [0]PETSC ERROR: [0] ISCreateGeneral line 658 >> /home/valera/petsc/src/vec/is/is/impls/general/general.c >> [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >> [0]PETSC ERROR: [0] PCSetUp line 894 >> /home/valera/petsc/src/ksp/pc/interface/precon.c >> [0]PETSC ERROR: --------------------- Error Message >> -------------------------------------------------------------- >> [0]PETSC ERROR: Signal received >> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >> for trouble shooting. >> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT >> Date: 2018-08-29 12:42:36 -0600 >> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >> Aug 29 14:20:42 2018 >> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc >> --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >> --download-viennacl --download-cusp >> [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >> [node50:77836] 1 more process has sent help message help-mpi-api.txt / >> mpi-abort >> [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to see >> all help / error messages >> >> >> >> On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. >> wrote: >> >>> Please send complete error message >>> >>> >>> > On Aug 29, 2018, at 3:40 PM, Manuel Valera wrote: >>> > >>> > Yeah, no sorry, i get the same error with -pc_type bjacobi >>> -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" >>> > >>> > >>> > Thanks and let me know of any progress on this issue, >>> > >>> > >>> > >>> > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera >>> wrote: >>> > Awesome, thanks! >>> > >>> > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. >>> wrote: >>> > >>> > >>> > > On Aug 29, 2018, at 3:26 PM, Manuel Valera >>> wrote: >>> > > >>> > > >>> > > >>> > > You may need to use just plain PCBJACOBI or PCASM for parallelism >>> and then SAVIENNACL sequentially on each block. >>> > > >>> > > >>> > > Can you elaborate a little in how to do this? do you mean i can only >>> use viennacl in serial at the moment or this is a suggestion of a >>> workaround on how to make it work? >>> > >>> > -pc_type bjacobi -sub_pc_type SAVIENNACL >>> > >>> > This will run in parallel and utilize the GPU for each block of >>> the preconditioner. >>> > >>> > Barry >>> > >>> > > >>> > > >>> > > Thanks, >>> > > >>> > > >>> > > >>> > > >>> > > >>> > > >>> > > >>> > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera >>> wrote: >>> > > > >>> > > > Hi everyone, >>> > > > >>> > > > Thanks for your responses, i understand communicating on this way >>> to this level of technicality can be hard, i still think we can work ways >>> to solve this problem though, >>> > > > >>> > > > I can say the following at this point: >>> > > > >>> > > > ? Program works without issues in any other non-gpu >>> preconditioner, just by calling -pc_type ### . >>> > > > ? Program works correctly with ViennaCL preconditioners with >>> mpirun -n 1, that is on one processor. >>> > > > ? Program breaks with every ViennaCL preconditioner when >>> attempting any more than 1 processors. >>> > > > ? I haven't tried other GPU preconditioners because ViennaCL >>> gave the best performance in 1 processor before. >>> > > > ? I have made sure the matrix type is mpiaijviennacl as it >>> is printed right before the error log. >>> > > > ? I am attaching what i think are the backtrace logs of the >>> run with two cores, as i have limited experience with this kind of >>> debugging, and i cannot make sense of what they say, please let me know if >>> you need me to do something else. >>> > > > >>> > > > Current options i can think of are giving you permission to clone >>> my model repo, or for you to guide me trough the process remotely, >>> > > > >>> > > > Thanks, >>> > > > >>> > > > .-.-.-.- >>> > > > >>> > > > >>> > > > The error i get is still: >>> > > > >>> > > > Matrix type: mpiaijviennacl >>> >>> > > > Of sizes: 125 x 125 >>> > > > Matrix type: mpiaijviennacl >>> >>> > > > Of sizes: 125 x 125 >>> > > > [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> > > > [0]PETSC ERROR: No support for this operation for this object type >>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>> > > > [0]PETSC ERROR: See >>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>> shooting. >>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>> valera Wed Aug 29 11:43:25 2018 >>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>> > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>> > > > [1]PETSC ERROR: >>> ------------------------------------------------------------------------ >>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>> Violation, probably memory access out of range >>> > > > [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] PetscTraceBackErrorHandler line 182 >>> /home/valera/petsc/src/sys/error/errtrace.c >>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>> /home/valera/petsc/src/sys/error/err.c >>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>> > > > [1]PETSC ERROR: [1] KSPSetUp line 294 >>> /home/valera/petsc/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 Development GIT revision: >>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>> valera Wed Aug 29 11:43:25 2018 >>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >>> > > > >>> -------------------------------------------------------------------------- >>> > > > MPI_ABORT was invoked on rank 1 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. >>> > > > >>> -------------------------------------------------------------------------- >>> > > > [0]PETSC ERROR: >>> ------------------------------------------------------------------------ >>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process >>> (or the batch system) has told this process to end >>> > > > [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. >>> > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 >>> /home/valera/petsc/src/mat/utils/gcreate.c >>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>> > > > [0]PETSC ERROR: [0] KSPSetUp line 294 >>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>> > > > [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> > > > [0]PETSC ERROR: Signal received >>> > > > [0]PETSC ERROR: See >>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>> shooting. >>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>> valera Wed Aug 29 11:43:25 2018 >>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file >>> > > > [node50:32783] 1 more process has sent help message >>> help-mpi-api.txt / mpi-abort >>> > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 >>> to see all help / error messages >>> > > > >>> > > > >>> > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp >>> wrote: >>> > > > Hi Manuel, >>> > > > >>> > > > as Barry said, it is hard for us to provide any help without >>> having a more complete picture of what is going on. >>> > > > >>> > > > The error you report seems to come from the AMG preconditioner in >>> ViennaCL. This can have many origins. Do other preconditioners run without >>> error? Can you run in a debugger and provide a complete backtrace? >>> > > > >>> > > > Thanks and best regards, >>> > > > Karli >>> > > > >>> > > > >>> > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: >>> > > > Talked too fast, >>> > > > >>> > > > After fixing that problem, i tried more than one mpi processor and >>> got the following: >>> > > > >>> > > > Matrix type: mpiaijviennacl >>> > > > Of sizes: 125 x 125 >>> > > > Matrix type: mpiaijviennacl >>> > > > Of sizes: 125 x 125 >>> > > > [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> > > > [0]PETSC ERROR: No support for this operation for this object type >>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>> > > > [0]PETSC ERROR: See >>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>> shooting. >>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>> valera Tue Aug 28 16:30:02 2018 >>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >>> http://saviennacl.cu> >>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>> > > > [1]PETSC ERROR: >>> ------------------------------------------------------------------------ >>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>> Violation, probably memory access out of range >>> > > > [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] PetscTraceBackErrorHandler line 182 >>> /home/valera/petsc/src/sys/error/errtrace.c >>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>> /home/valera/petsc/src/sys/error/err.c >>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>> http://saviennacl.cu> >>> > > > >>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: >>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>> valera Tue Aug 28 16:30:02 2018 >>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >>> > > > >>> -------------------------------------------------------------------------- >>> > > > MPI_ABORT was invoked on rank 1 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. >>> > > > >>> -------------------------------------------------------------------------- >>> > > > [0]PETSC ERROR: >>> ------------------------------------------------------------------------ >>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process >>> (or the batch system) has told this process to end >>> > > > [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. >>> > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>> /home/valera/petsc/src/sys/objects/tagm.c >>> > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >>> /home/valera/petsc/src/sys/objects/inherit.c >>> > > > [0]PETSC ERROR: [0] ISCreate line 35 >>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>> > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 >>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>> http://saviennacl.cu> >>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>> > > > [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> > > > [0]PETSC ERROR: Signal received >>> > > > [0]PETSC ERROR: See >>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>> shooting. >>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>> valera Tue Aug 28 16:30:02 2018 >>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >>> > > > [node50:30582] 1 more process has sent help message >>> help-mpi-api.txt / mpi-abort >>> > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 >>> to see all help / error messages >>> > > > >>> > > > >>> > > > >>> > > > It is currently running in 1 mpi processor + GPU but i would like >>> to call at least 16 mpi processors + GPU to do the rest of the data >>> management who is not part of the main laplacian on the mpi and the >>> laplacian solution on the GPU, is this currently possible? >>> > > > >>> > > > Thanks for your help, >>> > > > >>> > > > >>> > > > >>> > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera >> > wrote: >>> > > > >>> > > > Ok, i found the culprit and we can close this thread, >>> > > > >>> > > > The problem was a missing variable for setting the maximum >>> columns, >>> > > > which i deleted at some point without realizing. The error >>> message >>> > > > was too ambiguous to catch this so i had to compare with a >>> previous >>> > > > working version of the arguments of MatSetValues, it was >>> evident then. >>> > > > >>> > > > Good news is that i can now set the values with the viennacl >>> types too, >>> > > > >>> > > > Thanks for your kind help, >>> > > > >>> > > > Manuel >>> > > > >>> > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >>> > > > > wrote: >>> > > > >>> > > > >>> > > > 1) PetscMalloc() is never valid or needed in Fortran >>> > > > >>> > > > 2) there is no reason to use >>> DMSetMatrixPreallocateOnly() >>> > > > just use DMCreateMatrix() assuming that using a DM (DMDA, >>> > > > DMPLEX, etc) is suitable for your problem. >>> > > > >>> > > > At this end we are totally guessing at what you are >>> doing >>> > > > and so have little help we can provide. A simple, >>> nonworking >>> > > > code that tries to do what you would need would help us a >>> great >>> > > > deal in understanding that you are trying to do. >>> > > > >>> > > > Barry >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera >>> > > > > wrote: >>> > > > > >>> > > > > Matthew, PetscMalloc gives the same error, >>> > > > > >>> > > > > Barry, it would be very hard for me to get the code to a >>> > > > minimum working example, i guess all i need to understand >>> is how >>> > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() >>> instead >>> > > > of MatMPIAIJSetPreallocation() as we were doing before, is >>> there >>> > > > a simple example who does this in Fortran? >>> > > > > >>> > > > > Is the PetscMalloc call needed? is 'call >>> > > > PetscMalloc(1,row,ierr)' a valid, compilable call to >>> > > > PetscMalloc? what other reason may there be for this error >>> to >>> > > > happen ? >>> > > > > >>> > > > > Just remembering, that trying to setup the matrix with >>> the >>> > > > MatAIJSetPreallocation() brings up an error to acknowledge >>> the >>> > > > viennacl datatypes and that's why i'm trying to make this >>> change >>> > > > on your recommendation, >>> > > > > >>> > > > > Thanks for your help, >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > >>> > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >>> > > > > wrote: >>> > > > > >>> > > > > Send your code in a way we can compile and run it; >>> it must >>> > > > be some simple issue that is hard to communicate in email. >>> > > > > >>> > > > > Barry >>> > > > > >>> > > > > >>> > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >>> > > > > wrote: >>> > > > > > >>> > > > > > Hello everyone, >>> > > > > > >>> > > > > > I just had time to work on this again, and checked >>> the code >>> > > > for errors on the matrix entries, this is the exact code i >>> was >>> > > > using for creating the matrix without >>> > > > DMSetMatrixPreallocateOnly, using >>> MatMPIAIJSetPreallocation and >>> > > > it worked that way, but trying this way i get the same >>> 'Column >>> > > > too large' error using any number at the column position of >>> > > > MatSetValues, >>> > > > > > >>> > > > > > I have set up my code to print the column argument >>> (n) of >>> > > > MatSetValues and in this case is 7 (lower than 124), it >>> still >>> > > > gives error, even entering a specific number in the >>> MatSetValues >>> > > > column argument position gives the same error. >>> > > > > > >>> > > > > > So next i went back to ex.50 here: >>> > > > >>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html >>> > > > < >>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html >>> > >>> > > > and it has a very similar structure except the >>> PetscMalloc1() >>> > > > call, so i tried adding that and got: >>> > > > > > >>> > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: >>> undefined >>> > > > reference to `petscmalloc1_' >>> > > > > > >>> > > > > > Any ideas on this behaviour? >>> > > > > > >>> > > > > > Thanks so much, >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > >>> > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >>> > > > > wrote: >>> > > > > > >>> > > > > > Column too large: col 10980 max 124 >>> > > > > > >>> > > > > > You need to check the code that is generating the >>> matrix >>> > > > entries. The matrix has 124 columns but you are attempting >>> to >>> > > > put a value at column 10980 >>> > > > > > >>> > > > > > Barry >>> > > > > > >>> > > > > > >>> > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >>> > > > > wrote: >>> > > > > > > >>> > > > > > > Thanks Matthew and Barry, >>> > > > > > > >>> > > > > > > Now my code looks like: >>> > > > > > > >>> > > > > > > call >>> DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>> > > > > > > call MatSetFromOptions(A,ierr) >>> > > > > > > call MatSetUp(A,ierr) >>> > > > > > > [...] >>> > > > > > > call >>> > > > >>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>> > > > > > > [...] >>> > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >>> > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >>> > > > > > > >>> > > > > > > And i get a different error, now is: >>> > > > > > > >>> > > > > > > [0]PETSC ERROR: --------------------- Error Message >>> > > > >>> -------------------------------------------------------------- >>> > > > > > > [0]PETSC ERROR: Argument out of range >>> > > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 >>> > > > > > > [0]PETSC ERROR: See >>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>> > > > for >>> > > > trouble shooting. >>> > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >>> node50 >>> > > > by valera Wed Aug 15 19:40:00 2018 >>> > > > > > > [0]PETSC ERROR: Configure options >>> PETSC_ARCH=cuda-debug >>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in >>> > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c >>> > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>> > > > > > > >>> > > > > > > >>> > > > > > > Thanks again, >>> > > > > > > >>> > > > > > > >>> > > > > > > >>> > > > > > > >>> > > > > > > >>> > > > > > > >>> > > > > > > >>> > > > > > > >>> > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. >>> > > > > wrote: >>> > > > > > > >>> > > > > > > Should be >>> > > > > > > >>> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>> > > > > > > >>> > > > > > > and remove the rest. You need to set the type of >>> Mat >>> > > > you want the DM to return BEFORE you create the matrix. >>> > > > > > > >>> > > > > > > Barry >>> > > > > > > >>> > > > > > > >>> > > > > > > >>> > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >>> > > > > wrote: >>> > > > > > > > >>> > > > > > > > Ok thanks for clarifying that, i wasn't sure if >>> there >>> > > > were different types, >>> > > > > > > > >>> > > > > > > > Here is a stripped down version of my code, it >>> seems >>> > > > like the preallocation is working now since the matrix >>> > > > population part is working without problem, but here it is >>> for >>> > > > illustration purposes: >>> > > > > > > > >>> > > > > > > > call >>> DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>> > > > > > > > call MatSetFromOptions(A,ierr) >>> > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>> > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>> > > > > > > > call >>> > > > >>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>> > > > > > > > call MatSetUp(A,ierr) >>> > > > > > > > [...] >>> > > > > > > > call >>> > > > >>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>> > > > > > > > [...] >>> > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >>> > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >>> > > > > > > > >>> > > > > > > > Adding the first line there did the trick, >>> > > > > > > > >>> > > > > > > > Now the problem seems to be the program is not >>> > > > recognizing the matrix as ViennaCL type when i try with >>> more >>> > > > than one processor, i get now: >>> > > > > > > > >>> > > > > > > > [0]PETSC ERROR: --------------------- Error >>> Message >>> > > > >>> -------------------------------------------------------------- >>> > > > > > > > [0]PETSC ERROR: No support for this operation for >>> this >>> > > > object type >>> > > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL >>> matrices >>> > > > > > > > [0]PETSC ERROR: See >>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>> > > > for >>> > > > trouble shooting. >>> > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >>> > > > node50 by valera Wed Aug 15 14:44:22 2018 >>> > > > > > > > [0]PETSC ERROR: Configure options >>> PETSC_ARCH=cuda-debug >>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>> > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/ >>> saviennacl.cu >>> > > > >>> > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>> > > > /home/valera/petsc/src/ksp/pc/interface/precon.c >>> > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>> > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>> > > > > > > > >>> > > > > > > > When running with: >>> > > > > > > > >>> > > > > > > > mpirun -n 1 ./gcmLEP.GPU >>> > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl >>> > > > -pc_type saviennacl -log_view >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > Thanks, >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley >>> > > > > wrote: >>> > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >>> > > > > wrote: >>> > > > > > > > It seems to be resumed on: I do not know how to >>> > > > preallocate a DM Matrix correctly. >>> > > > > > > > >>> > > > > > > > There is only one matrix type, Mat. There are no >>> > > > separate DM matrices. A DM can create a matrix for you >>> > > > > > > > using DMCreateMatrix(), but that is a Mat and it >>> is >>> > > > preallocated correctly. I am not sure what you are doing. >>> > > > > > > > >>> > > > > > > > Thanks, >>> > > > > > > > >>> > > > > > > > Matt >>> > > > > > > > >>> > > > > > > > The interesting part is that it only breaks when >>> i need >>> > > > to populate a GPU matrix from MPI, so kudos on that, but it >>> > > > seems i need to do better on my code to get this setup >>> working, >>> > > > > > > > >>> > > > > > > > Any help would be appreciated, >>> > > > > > > > >>> > > > > > > > Thanks, >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >>> > > > > wrote: >>> > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >>> > > > > wrote: >>> > > > > > > > Thanks Matthew, >>> > > > > > > > >>> > > > > > > > I try to do that when calling: >>> > > > > > > > >>> > > > > > > > call >>> > > > >>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>> > > > > > > > >>> > > > > > > > But i am not aware on how to do this for the DM >>> if it >>> > > > needs something more specific/different, >>> > > > > > > > >>> > > > > > > > The error says that your preallocation is wrong >>> for the >>> > > > values you are putting in. The DM does not control either, >>> > > > > > > > so I do not understand your email. >>> > > > > > > > >>> > > > > > > > Thanks, >>> > > > > > > > >>> > > > > > > > Matt >>> > > > > > > > >>> > > > > > > > Thanks, >>> > > > > > > > >>> > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >>> > > > > wrote: >>> > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>> > > > > wrote: >>> > > > > > > > Hello PETSc devs, >>> > > > > > > > >>> > > > > > > > I am running into an error when trying to use the >>> > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code >>> runs >>> > > > for MATSEQAIJVIENNACL type in one processor. The error >>> happens >>> > > > when calling MatSetValues for this specific configuration. >>> It >>> > > > does not occur when using MPI DMMatrix types only. >>> > > > > > > > >>> > > > > > > > The DM properly preallocates the matrix. I am >>> assuming >>> > > > you do not here. >>> > > > > > > > >>> > > > > > > > Matt >>> > > > > > > > >>> > > > > > > > Any help will be appreciated, >>> > > > > > > > >>> > > > > > > > Thanks, >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > My program call: >>> > > > > > > > >>> > > > > > > > mpirun -n 2 ./gcmLEP.GPU >>> > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl >>> > > > -pc_type saviennacl -log_view >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > The error (repeats after each MatSetValues call): >>> > > > > > > > >>> > > > > > > > [1]PETSC ERROR: --------------------- Error >>> Message >>> > > > >>> -------------------------------------------------------------- >>> > > > > > > > [1]PETSC ERROR: Argument out of range >>> > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global >>> > > > row/column (75, 50) into matrix >>> > > > > > > > [1]PETSC ERROR: See >>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>> > > > for >>> > > > trouble shooting. >>> > > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: >>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>> > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >>> > > > node50 by valera Wed Aug 15 13:10:44 2018 >>> > > > > > > > [1]PETSC ERROR: Configure options >>> PETSC_ARCH=cuda-debug >>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>> > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 >>> in >>> > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>> > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > My Code structure: >>> > > > > > > > >>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>> > > > > > > > call MatSetFromOptions(A,ierr) >>> > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, >>> ierr) >>> > > > > > > > if (numprocs > 1) then ! set matrix type parallel >>> > > > > > > > ! Get local size >>> > > > > > > > call >>> DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>> > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) >>> > > > > > > > call VecDestroy(Tmpnat,ierr) >>> > > > > > > > ! Set matrix >>> > > > > > > > #ifdef GPU >>> > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >>> > > > > > > > call >>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>> > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>> > > > > > > > print*,'SETTING GPU TYPES' >>> > > > > > > > #else >>> > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>> > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) >>> > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! >>> > > > > > > > #endif >>> > > > > > > > call >>> > > > >>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>> > > > > > > > else ! set matrix type >>> sequential >>> > > > > > > > #ifdef GPU >>> > > > > > > > call >>> DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>> > > > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>> > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>> > > > > > > > print*,'SETTING GPU TYPES' >>> > > > > > > > #else >>> > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>> > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >>> > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) >>> > > > > > > > #endif >>> > > > > > > > call MatSetUp(A,ierr) >>> > > > > > > > call >>> > > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>> > > > > > > > >>> > > > > > > > do k=zstart,zend-1 >>> > > > > > > > do j=ystart,yend-1 >>> > > > > > > > do i=xstart,xend-1 >>> > > > > > > > [..] >>> > > > > > > > call >>> > > > >>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>> > > > > > > > [..] >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > -- >>> > > > > > > > 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 >>> > > > > > > > >>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>> > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > -- >>> > > > > > > > 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 >>> > > > > > > > >>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>> > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > >>> > > > > > > > -- >>> > > > > > > > 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 >>> > > > > > > > >>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>> > > > >>> > > > > > > > >>> > > > > > > >>> > > > > > > >>> > > > > > >>> > > > > > >>> > > > > >>> > > > > >>> > > > >>> > > > >>> > > > >>> > > > >>> > > > >>> > >>> > >>> > >>> >>> >> > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From mvalera-w at sdsu.edu Wed Aug 29 17:21:29 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Wed, 29 Aug 2018 15:21:29 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: I understand that Matthew, thanks, I am trying to see if i get any speedup in this configuration, otherwise i will be waiting for the MPIAIJ support on PETSc, Is there any other gpu preconditioner that works on parallel matrices directly? Thanks again, On Wed, Aug 29, 2018 at 3:05 PM, Matthew Knepley wrote: > On Wed, Aug 29, 2018 at 5:49 PM Manuel Valera wrote: > >> Update: >> >> I made it work like you suggested Barry, i had to comment the code line >> to set up the pc_type saviennacl, that way i am getting as ksp_view: >> >> KSP Object: 2 MPI processes >> type: cg >> maximum iterations=10000, initial guess is zero >> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >> left preconditioning >> using PRECONDITIONED norm type for convergence test >> PC Object: 2 MPI processes >> type: bjacobi >> number of blocks = 2 >> Local solve is same for all blocks, in the following KSP and PC >> objects: >> KSP Object: (sub_) 1 MPI processes >> type: preonly >> maximum iterations=10000, initial guess is zero >> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. >> left preconditioning >> using NONE norm type for convergence test >> PC Object: (sub_) 1 MPI processes >> type: ilu >> out-of-place factorization >> 0 levels of fill >> tolerance for zero pivot 2.22045e-14 >> matrix ordering: natural >> factor fill ratio given 1., needed 1. >> Factored matrix follows: >> Mat Object: 1 MPI processes >> type: seqaij >> rows=75, cols=75 >> package used to perform factorization: petsc >> total: nonzeros=927, allocated nonzeros=927 >> total number of mallocs used during MatSetValues calls =0 >> not using I-node routines >> linear system matrix = precond matrix: >> Mat Object: 1 MPI processes >> type: seqaijviennacl >> rows=75, cols=75 >> total: nonzeros=927, allocated nonzeros=1335 >> total number of mallocs used during MatSetValues calls =84 >> not using I-node routines >> linear system matrix = precond matrix: >> Mat Object: 2 MPI processes >> type: mpiaijviennacl >> rows=125, cols=125 >> total: nonzeros=1685, allocated nonzeros=2885 >> total number of mallocs used during MatSetValues calls =184 >> has attached near null space >> Press_Max: 1.9995807630564922E-004 >> >> >> This is what we want, right? >> >> Still if i try using pc_type saviennacl directly it breaks, >> > > You are missing the point of the error message. > > We do not support SAVIENNACL on parallel matrices (MPIAIJ). We do support > it > on serial matrices (SEQAIJ). When you are setting in directly, you are > applying it > to a parallel matrix. If you use Block-Jacobi, you are applying it to each > submatrix, > and those submatrices are all serial. > > Thanks, > > Matt > > >> Thanks for your help i'll try my speedup like this, >> >> >> >> >> >> On Wed, Aug 29, 2018 at 2:21 PM, Manuel Valera >> wrote: >> >>> Ok, executing with: >>> >>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>> jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view >>> >>> >>> I get: >>> >>> >>> SETTING GPU TYPES >>> Matrix type: mpiaijviennacl >>> >>> Of sizes: 125 x 125 >>> Matrix type: mpiaijviennacl >>> >>> Of sizes: 125 x 125 >>> [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> [0]PETSC ERROR: No support for this operation for this object type >>> [0]PETSC ERROR: Currently only handles ViennaCL matrices >>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >>> for trouble shooting. >>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 >>> GIT Date: 2018-08-29 12:42:36 -0600 >>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >>> Aug 29 14:20:42 2018 >>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc >>> --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>> --download-viennacl --download-cusp >>> [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>> [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/ >>> interface/precon.c >>> [1]PETSC ERROR: ------------------------------ >>> ------------------------------------------ >>> [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, >>> probably memory access out of range >>> [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] PetscTraceBackErrorHandler line 182 >>> /home/valera/petsc/src/sys/error/errtrace.c >>> [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/ >>> error/err.c >>> [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>> [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >>> interface/precon.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 Development GIT revision: v3.9.3-1264-g6fb0cd4 >>> GIT Date: 2018-08-29 12:42:36 -0600 >>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >>> Aug 29 14:20:42 2018 >>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc >>> --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>> --download-viennacl --download-cusp >>> [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >>> ------------------------------------------------------------ >>> -------------- >>> MPI_ABORT was invoked on rank 1 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. >>> ------------------------------------------------------------ >>> -------------- >>> [0]PETSC ERROR: ------------------------------ >>> ------------------------------------------ >>> [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the >>> batch system) has told this process to end >>> [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. >>> [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>> /home/valera/petsc/src/sys/objects/tagm.c >>> [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 >>> /home/valera/petsc/src/sys/objects/inherit.c >>> [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/ >>> is/interface/isreg.c >>> [0]PETSC ERROR: [0] ISCreateGeneral line 658 >>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>> [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>> [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >>> interface/precon.c >>> [0]PETSC ERROR: --------------------- Error Message >>> -------------------------------------------------------------- >>> [0]PETSC ERROR: Signal received >>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >>> for trouble shooting. >>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 >>> GIT Date: 2018-08-29 12:42:36 -0600 >>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >>> Aug 29 14:20:42 2018 >>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc >>> --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>> --download-viennacl --download-cusp >>> [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >>> [node50:77836] 1 more process has sent help message help-mpi-api.txt / >>> mpi-abort >>> [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to see >>> all help / error messages >>> >>> >>> >>> On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. >>> wrote: >>> >>>> Please send complete error message >>>> >>>> >>>> > On Aug 29, 2018, at 3:40 PM, Manuel Valera >>>> wrote: >>>> > >>>> > Yeah, no sorry, i get the same error with -pc_type bjacobi >>>> -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" >>>> > >>>> > >>>> > Thanks and let me know of any progress on this issue, >>>> > >>>> > >>>> > >>>> > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera >>>> wrote: >>>> > Awesome, thanks! >>>> > >>>> > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. >>>> wrote: >>>> > >>>> > >>>> > > On Aug 29, 2018, at 3:26 PM, Manuel Valera >>>> wrote: >>>> > > >>>> > > >>>> > > >>>> > > You may need to use just plain PCBJACOBI or PCASM for parallelism >>>> and then SAVIENNACL sequentially on each block. >>>> > > >>>> > > >>>> > > Can you elaborate a little in how to do this? do you mean i can >>>> only use viennacl in serial at the moment or this is a suggestion of a >>>> workaround on how to make it work? >>>> > >>>> > -pc_type bjacobi -sub_pc_type SAVIENNACL >>>> > >>>> > This will run in parallel and utilize the GPU for each block of >>>> the preconditioner. >>>> > >>>> > Barry >>>> > >>>> > > >>>> > > >>>> > > Thanks, >>>> > > >>>> > > >>>> > > >>>> > > >>>> > > >>>> > > >>>> > > >>>> > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera >>>> wrote: >>>> > > > >>>> > > > Hi everyone, >>>> > > > >>>> > > > Thanks for your responses, i understand communicating on this way >>>> to this level of technicality can be hard, i still think we can work ways >>>> to solve this problem though, >>>> > > > >>>> > > > I can say the following at this point: >>>> > > > >>>> > > > ? Program works without issues in any other non-gpu >>>> preconditioner, just by calling -pc_type ### . >>>> > > > ? Program works correctly with ViennaCL preconditioners >>>> with mpirun -n 1, that is on one processor. >>>> > > > ? Program breaks with every ViennaCL preconditioner when >>>> attempting any more than 1 processors. >>>> > > > ? I haven't tried other GPU preconditioners because >>>> ViennaCL gave the best performance in 1 processor before. >>>> > > > ? I have made sure the matrix type is mpiaijviennacl as it >>>> is printed right before the error log. >>>> > > > ? I am attaching what i think are the backtrace logs of the >>>> run with two cores, as i have limited experience with this kind of >>>> debugging, and i cannot make sense of what they say, please let me know if >>>> you need me to do something else. >>>> > > > >>>> > > > Current options i can think of are giving you permission to clone >>>> my model repo, or for you to guide me trough the process remotely, >>>> > > > >>>> > > > Thanks, >>>> > > > >>>> > > > .-.-.-.- >>>> > > > >>>> > > > >>>> > > > The error i get is still: >>>> > > > >>>> > > > Matrix type: mpiaijviennacl >>>> >>>> > > > Of sizes: 125 x 125 >>>> > > > Matrix type: mpiaijviennacl >>>> >>>> > > > Of sizes: 125 x 125 >>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>> -------------------------------------------------------------- >>>> > > > [0]PETSC ERROR: No support for this operation for this object type >>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>> documentation/faq.html for trouble shooting. >>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>> valera Wed Aug 29 11:43:25 2018 >>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>> --download-viennacl >>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>> > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>> > > > [1]PETSC ERROR: ------------------------------ >>>> ------------------------------------------ >>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>> Violation, probably memory access out of range >>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>> /home/valera/petsc/src/sys/error/errtrace.c >>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>> /home/valera/petsc/src/sys/error/err.c >>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>> > > > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: >>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>> valera Wed Aug 29 11:43:25 2018 >>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>> --download-viennacl >>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown >>>> file >>>> > > > ------------------------------------------------------------ >>>> -------------- >>>> > > > MPI_ABORT was invoked on rank 1 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. >>>> > > > ------------------------------------------------------------ >>>> -------------- >>>> > > > [0]PETSC ERROR: ------------------------------ >>>> ------------------------------------------ >>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process >>>> (or the batch system) has told this process to end >>>> > > > [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. >>>> > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 >>>> /home/valera/petsc/src/mat/utils/gcreate.c >>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>> > > > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ >>>> ksp/interface/itfunc.c >>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>> -------------------------------------------------------------- >>>> > > > [0]PETSC ERROR: Signal received >>>> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>> documentation/faq.html for trouble shooting. >>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>> valera Wed Aug 29 11:43:25 2018 >>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>> --download-viennacl >>>> > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown >>>> file >>>> > > > [node50:32783] 1 more process has sent help message >>>> help-mpi-api.txt / mpi-abort >>>> > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 >>>> to see all help / error messages >>>> > > > >>>> > > > >>>> > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp >>>> wrote: >>>> > > > Hi Manuel, >>>> > > > >>>> > > > as Barry said, it is hard for us to provide any help without >>>> having a more complete picture of what is going on. >>>> > > > >>>> > > > The error you report seems to come from the AMG preconditioner in >>>> ViennaCL. This can have many origins. Do other preconditioners run without >>>> error? Can you run in a debugger and provide a complete backtrace? >>>> > > > >>>> > > > Thanks and best regards, >>>> > > > Karli >>>> > > > >>>> > > > >>>> > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: >>>> > > > Talked too fast, >>>> > > > >>>> > > > After fixing that problem, i tried more than one mpi processor >>>> and got the following: >>>> > > > >>>> > > > Matrix type: mpiaijviennacl >>>> > > > Of sizes: 125 x 125 >>>> > > > Matrix type: mpiaijviennacl >>>> > > > Of sizes: 125 x 125 >>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>> -------------------------------------------------------------- >>>> > > > [0]PETSC ERROR: No support for this operation for this object type >>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>> documentation/faq.html for trouble shooting. >>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>> valera Tue Aug 28 16:30:02 2018 >>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>> --download-viennacl >>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >>>> http://saviennacl.cu> >>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>> > > > [1]PETSC ERROR: ------------------------------ >>>> ------------------------------------------ >>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>> Violation, probably memory access out of range >>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>> /home/valera/petsc/src/sys/error/errtrace.c >>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>> /home/valera/petsc/src/sys/error/err.c >>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>> http://saviennacl.cu> >>>> > > > >>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: >>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>> valera Tue Aug 28 16:30:02 2018 >>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>> --download-viennacl >>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown >>>> file >>>> > > > ------------------------------------------------------------ >>>> -------------- >>>> > > > MPI_ABORT was invoked on rank 1 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. >>>> > > > ------------------------------------------------------------ >>>> -------------- >>>> > > > [0]PETSC ERROR: ------------------------------ >>>> ------------------------------------------ >>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process >>>> (or the batch system) has told this process to end >>>> > > > [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. >>>> > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>> /home/valera/petsc/src/sys/objects/tagm.c >>>> > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >>>> /home/valera/petsc/src/sys/objects/inherit.c >>>> > > > [0]PETSC ERROR: [0] ISCreate line 35 >>>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>>> > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 >>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>> http://saviennacl.cu> >>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>> -------------------------------------------------------------- >>>> > > > [0]PETSC ERROR: Signal received >>>> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>> documentation/faq.html for trouble shooting. >>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>> valera Tue Aug 28 16:30:02 2018 >>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>> --download-viennacl >>>> > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown >>>> file >>>> > > > [node50:30582] 1 more process has sent help message >>>> help-mpi-api.txt / mpi-abort >>>> > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 >>>> to see all help / error messages >>>> > > > >>>> > > > >>>> > > > >>>> > > > It is currently running in 1 mpi processor + GPU but i would like >>>> to call at least 16 mpi processors + GPU to do the rest of the data >>>> management who is not part of the main laplacian on the mpi and the >>>> laplacian solution on the GPU, is this currently possible? >>>> > > > >>>> > > > Thanks for your help, >>>> > > > >>>> > > > >>>> > > > >>>> > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera < >>>> mvalera-w at sdsu.edu > wrote: >>>> > > > >>>> > > > Ok, i found the culprit and we can close this thread, >>>> > > > >>>> > > > The problem was a missing variable for setting the maximum >>>> columns, >>>> > > > which i deleted at some point without realizing. The error >>>> message >>>> > > > was too ambiguous to catch this so i had to compare with a >>>> previous >>>> > > > working version of the arguments of MatSetValues, it was >>>> evident then. >>>> > > > >>>> > > > Good news is that i can now set the values with the viennacl >>>> types too, >>>> > > > >>>> > > > Thanks for your kind help, >>>> > > > >>>> > > > Manuel >>>> > > > >>>> > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >>>> > > > > wrote: >>>> > > > >>>> > > > >>>> > > > 1) PetscMalloc() is never valid or needed in Fortran >>>> > > > >>>> > > > 2) there is no reason to use >>>> DMSetMatrixPreallocateOnly() >>>> > > > just use DMCreateMatrix() assuming that using a DM (DMDA, >>>> > > > DMPLEX, etc) is suitable for your problem. >>>> > > > >>>> > > > At this end we are totally guessing at what you are >>>> doing >>>> > > > and so have little help we can provide. A simple, >>>> nonworking >>>> > > > code that tries to do what you would need would help us a >>>> great >>>> > > > deal in understanding that you are trying to do. >>>> > > > >>>> > > > Barry >>>> > > > >>>> > > > >>>> > > > >>>> > > > >>>> > > > >>>> > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera >>>> > > > > wrote: >>>> > > > > >>>> > > > > Matthew, PetscMalloc gives the same error, >>>> > > > > >>>> > > > > Barry, it would be very hard for me to get the code to >>>> a >>>> > > > minimum working example, i guess all i need to understand >>>> is how >>>> > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() >>>> instead >>>> > > > of MatMPIAIJSetPreallocation() as we were doing before, >>>> is there >>>> > > > a simple example who does this in Fortran? >>>> > > > > >>>> > > > > Is the PetscMalloc call needed? is 'call >>>> > > > PetscMalloc(1,row,ierr)' a valid, compilable call to >>>> > > > PetscMalloc? what other reason may there be for this >>>> error to >>>> > > > happen ? >>>> > > > > >>>> > > > > Just remembering, that trying to setup the matrix with >>>> the >>>> > > > MatAIJSetPreallocation() brings up an error to >>>> acknowledge the >>>> > > > viennacl datatypes and that's why i'm trying to make this >>>> change >>>> > > > on your recommendation, >>>> > > > > >>>> > > > > Thanks for your help, >>>> > > > > >>>> > > > > >>>> > > > > >>>> > > > > >>>> > > > > >>>> > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >>>> > > > > wrote: >>>> > > > > >>>> > > > > Send your code in a way we can compile and run it; >>>> it must >>>> > > > be some simple issue that is hard to communicate in email. >>>> > > > > >>>> > > > > Barry >>>> > > > > >>>> > > > > >>>> > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >>>> > > > > wrote: >>>> > > > > > >>>> > > > > > Hello everyone, >>>> > > > > > >>>> > > > > > I just had time to work on this again, and checked >>>> the code >>>> > > > for errors on the matrix entries, this is the exact code >>>> i was >>>> > > > using for creating the matrix without >>>> > > > DMSetMatrixPreallocateOnly, using >>>> MatMPIAIJSetPreallocation and >>>> > > > it worked that way, but trying this way i get the same >>>> 'Column >>>> > > > too large' error using any number at the column position >>>> of >>>> > > > MatSetValues, >>>> > > > > > >>>> > > > > > I have set up my code to print the column argument >>>> (n) of >>>> > > > MatSetValues and in this case is 7 (lower than 124), it >>>> still >>>> > > > gives error, even entering a specific number in the >>>> MatSetValues >>>> > > > column argument position gives the same error. >>>> > > > > > >>>> > > > > > So next i went back to ex.50 here: >>>> > > > http://www.mcs.anl.gov/petsc/ >>>> petsc-current/src/ts/examples/tutorials/ex50.c.html >>>> > > > >>> examples/tutorials/ex50.c.html> >>>> > > > and it has a very similar structure except the >>>> PetscMalloc1() >>>> > > > call, so i tried adding that and got: >>>> > > > > > >>>> > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: >>>> undefined >>>> > > > reference to `petscmalloc1_' >>>> > > > > > >>>> > > > > > Any ideas on this behaviour? >>>> > > > > > >>>> > > > > > Thanks so much, >>>> > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >>>> > > > > wrote: >>>> > > > > > >>>> > > > > > Column too large: col 10980 max 124 >>>> > > > > > >>>> > > > > > You need to check the code that is generating the >>>> matrix >>>> > > > entries. The matrix has 124 columns but you are >>>> attempting to >>>> > > > put a value at column 10980 >>>> > > > > > >>>> > > > > > Barry >>>> > > > > > >>>> > > > > > >>>> > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >>>> > > > > wrote: >>>> > > > > > > >>>> > > > > > > Thanks Matthew and Barry, >>>> > > > > > > >>>> > > > > > > Now my code looks like: >>>> > > > > > > >>>> > > > > > > call DMSetMatrixPreallocateOnly( >>>> daDummy,PETSC_TRUE,ierr) >>>> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>> > > > > > > call MatSetFromOptions(A,ierr) >>>> > > > > > > call MatSetUp(A,ierr) >>>> > > > > > > [...] >>>> > > > > > > call >>>> > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), >>>> INSERT_VALUES,ierr) >>>> > > > > > > [...] >>>> > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >>>> > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >>>> > > > > > > >>>> > > > > > > And i get a different error, now is: >>>> > > > > > > >>>> > > > > > > [0]PETSC ERROR: --------------------- Error Message >>>> > > > ----------------------------- >>>> --------------------------------- >>>> > > > > > > [0]PETSC ERROR: Argument out of range >>>> > > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 >>>> > > > > > > [0]PETSC ERROR: See >>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>> > > > for >>>> > > > trouble shooting. >>>> > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>> > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named >>>> node50 >>>> > > > by valera Wed Aug 15 19:40:00 2018 >>>> > > > > > > [0]PETSC ERROR: Configure options >>>> PETSC_ARCH=cuda-debug >>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>> --with-shared-libraries=1 >>>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>> > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 >>>> in >>>> > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c >>>> > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > Thanks again, >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. >>>> > > > > wrote: >>>> > > > > > > >>>> > > > > > > Should be >>>> > > > > > > >>>> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>> > > > > > > >>>> > > > > > > and remove the rest. You need to set the type of >>>> Mat >>>> > > > you want the DM to return BEFORE you create the matrix. >>>> > > > > > > >>>> > > > > > > Barry >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > >>>> > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >>>> > > > > wrote: >>>> > > > > > > > >>>> > > > > > > > Ok thanks for clarifying that, i wasn't sure if >>>> there >>>> > > > were different types, >>>> > > > > > > > >>>> > > > > > > > Here is a stripped down version of my code, it >>>> seems >>>> > > > like the preallocation is working now since the matrix >>>> > > > population part is working without problem, but here it >>>> is for >>>> > > > illustration purposes: >>>> > > > > > > > >>>> > > > > > > > call DMSetMatrixPreallocateOnly( >>>> daDummy,PETSC_TRUE,ierr) >>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>> > > > > > > > call DMSetMatType(daDummy, >>>> MATMPIAIJVIENNACL,ierr) >>>> > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>> > > > > > > > call >>>> > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>>> PETSC_NULL_INTEGER,ierr) >>>> > > > > > > > call MatSetUp(A,ierr) >>>> > > > > > > > [...] >>>> > > > > > > > call >>>> > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), >>>> INSERT_VALUES,ierr) >>>> > > > > > > > [...] >>>> > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, >>>> ierr) >>>> > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >>>> > > > > > > > >>>> > > > > > > > Adding the first line there did the trick, >>>> > > > > > > > >>>> > > > > > > > Now the problem seems to be the program is not >>>> > > > recognizing the matrix as ViennaCL type when i try with >>>> more >>>> > > > than one processor, i get now: >>>> > > > > > > > >>>> > > > > > > > [0]PETSC ERROR: --------------------- Error >>>> Message >>>> > > > ----------------------------- >>>> --------------------------------- >>>> > > > > > > > [0]PETSC ERROR: No support for this operation >>>> for this >>>> > > > object type >>>> > > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL >>>> matrices >>>> > > > > > > > [0]PETSC ERROR: See >>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>> > > > for >>>> > > > trouble shooting. >>>> > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>> > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>> named >>>> > > > node50 by valera Wed Aug 15 14:44:22 2018 >>>> > > > > > > > [0]PETSC ERROR: Configure options >>>> PETSC_ARCH=cuda-debug >>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>> --with-shared-libraries=1 >>>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>> > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 >>>> in >>>> > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/savien >>>> nacl.cu >>>> > > > >>>> > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>> > > > /home/valera/petsc/src/ksp/pc/interface/precon.c >>>> > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>> > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>> > > > > > > > >>>> > > > > > > > When running with: >>>> > > > > > > > >>>> > > > > > > > mpirun -n 1 ./gcmLEP.GPU >>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>> aijviennacl >>>> > > > -pc_type saviennacl -log_view >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > Thanks, >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley >>>> > > > > wrote: >>>> > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >>>> > > > > wrote: >>>> > > > > > > > It seems to be resumed on: I do not know how to >>>> > > > preallocate a DM Matrix correctly. >>>> > > > > > > > >>>> > > > > > > > There is only one matrix type, Mat. There are no >>>> > > > separate DM matrices. A DM can create a matrix for you >>>> > > > > > > > using DMCreateMatrix(), but that is a Mat and it >>>> is >>>> > > > preallocated correctly. I am not sure what you are doing. >>>> > > > > > > > >>>> > > > > > > > Thanks, >>>> > > > > > > > >>>> > > > > > > > Matt >>>> > > > > > > > >>>> > > > > > > > The interesting part is that it only breaks when >>>> i need >>>> > > > to populate a GPU matrix from MPI, so kudos on that, but >>>> it >>>> > > > seems i need to do better on my code to get this setup >>>> working, >>>> > > > > > > > >>>> > > > > > > > Any help would be appreciated, >>>> > > > > > > > >>>> > > > > > > > Thanks, >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >>>> > > > > wrote: >>>> > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >>>> > > > > wrote: >>>> > > > > > > > Thanks Matthew, >>>> > > > > > > > >>>> > > > > > > > I try to do that when calling: >>>> > > > > > > > >>>> > > > > > > > call >>>> > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>>> PETSC_NULL_INTEGER,ierr) >>>> > > > > > > > >>>> > > > > > > > But i am not aware on how to do this for the DM >>>> if it >>>> > > > needs something more specific/different, >>>> > > > > > > > >>>> > > > > > > > The error says that your preallocation is wrong >>>> for the >>>> > > > values you are putting in. The DM does not control either, >>>> > > > > > > > so I do not understand your email. >>>> > > > > > > > >>>> > > > > > > > Thanks, >>>> > > > > > > > >>>> > > > > > > > Matt >>>> > > > > > > > >>>> > > > > > > > Thanks, >>>> > > > > > > > >>>> > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >>>> > > > > wrote: >>>> > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>>> > > > > wrote: >>>> > > > > > > > Hello PETSc devs, >>>> > > > > > > > >>>> > > > > > > > I am running into an error when trying to use the >>>> > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code >>>> runs >>>> > > > for MATSEQAIJVIENNACL type in one processor. The error >>>> happens >>>> > > > when calling MatSetValues for this specific >>>> configuration. It >>>> > > > does not occur when using MPI DMMatrix types only. >>>> > > > > > > > >>>> > > > > > > > The DM properly preallocates the matrix. I am >>>> assuming >>>> > > > you do not here. >>>> > > > > > > > >>>> > > > > > > > Matt >>>> > > > > > > > >>>> > > > > > > > Any help will be appreciated, >>>> > > > > > > > >>>> > > > > > > > Thanks, >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > My program call: >>>> > > > > > > > >>>> > > > > > > > mpirun -n 2 ./gcmLEP.GPU >>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>> aijviennacl >>>> > > > -pc_type saviennacl -log_view >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > The error (repeats after each MatSetValues call): >>>> > > > > > > > >>>> > > > > > > > [1]PETSC ERROR: --------------------- Error >>>> Message >>>> > > > ----------------------------- >>>> --------------------------------- >>>> > > > > > > > [1]PETSC ERROR: Argument out of range >>>> > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global >>>> > > > row/column (75, 50) into matrix >>>> > > > > > > > [1]PETSC ERROR: See >>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>> > > > for >>>> > > > trouble shooting. >>>> > > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: >>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>> > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>> named >>>> > > > node50 by valera Wed Aug 15 13:10:44 2018 >>>> > > > > > > > [1]PETSC ERROR: Configure options >>>> PETSC_ARCH=cuda-debug >>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>> --with-shared-libraries=1 >>>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>> > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line >>>> 608 in >>>> > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>>> > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > My Code structure: >>>> > > > > > > > >>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>> > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, >>>> ierr) >>>> > > > > > > > if (numprocs > 1) then ! set matrix type >>>> parallel >>>> > > > > > > > ! Get local size >>>> > > > > > > > call DMDACreateNaturalVector( >>>> daDummy,Tmpnat,ierr) >>>> > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) >>>> > > > > > > > call VecDestroy(Tmpnat,ierr) >>>> > > > > > > > ! Set matrix >>>> > > > > > > > #ifdef GPU >>>> > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >>>> > > > > > > > call DMSetMatType(daDummy, >>>> MATMPIAIJVIENNACL,ierr) >>>> > > > > > > > call DMSetVecType(daDummy, >>>> VECMPIVIENNACL,ierr) >>>> > > > > > > > print*,'SETTING GPU TYPES' >>>> > > > > > > > #else >>>> > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>> > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) >>>> > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! >>>> > > > > > > > #endif >>>> > > > > > > > call >>>> > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>>> PETSC_NULL_INTEGER,ierr) >>>> > > > > > > > else ! set matrix type >>>> sequential >>>> > > > > > > > #ifdef GPU >>>> > > > > > > > call DMSetMatType(daDummy, >>>> MATSEQAIJVIENNACL,ierr) >>>> > > > > > > > call DMSetVecType(daDummy, >>>> VECSEQVIENNACL,ierr) >>>> > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>> > > > > > > > print*,'SETTING GPU TYPES' >>>> > > > > > > > #else >>>> > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>> > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >>>> > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) >>>> > > > > > > > #endif >>>> > > > > > > > call MatSetUp(A,ierr) >>>> > > > > > > > call >>>> > > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>> > > > > > > > >>>> > > > > > > > do k=zstart,zend-1 >>>> > > > > > > > do j=ystart,yend-1 >>>> > > > > > > > do i=xstart,xend-1 >>>> > > > > > > > [..] >>>> > > > > > > > call >>>> > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1), >>>> INSERT_VALUES,ierr) >>>> > > > > > > > [..] >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > -- >>>> > > > > > > > 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 >>>> > > > > > > > >>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>> > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > -- >>>> > > > > > > > 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 >>>> > > > > > > > >>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>> > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > >>>> > > > > > > > -- >>>> > > > > > > > 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 >>>> > > > > > > > >>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>> > > > >>>> > > > > > > > >>>> > > > > > > >>>> > > > > > > >>>> > > > > > >>>> > > > > > >>>> > > > > >>>> > > > > >>>> > > > >>>> > > > >>>> > > > >>>> > > > >>>> > > > >>>> > >>>> > >>>> > >>>> >>>> >>> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Aug 29 17:56:02 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 29 Aug 2018 22:56:02 +0000 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: Below is not using the GPUs. > On Aug 29, 2018, at 4:49 PM, Manuel Valera wrote: > > Update: > > I made it work like you suggested Barry, i had to comment the code line to set up the pc_type saviennacl, that way i am getting as ksp_view: > > KSP Object: 2 MPI processes > type: cg > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-07, absolute=1e-50, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: 2 MPI processes > type: bjacobi > number of blocks = 2 > Local solve is same for all blocks, in the following KSP and PC objects: > KSP Object: (sub_) 1 MPI processes > type: preonly > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. > left preconditioning > using NONE norm type for convergence test > PC Object: (sub_) 1 MPI processes > type: ilu > out-of-place factorization > 0 levels of fill > tolerance for zero pivot 2.22045e-14 > matrix ordering: natural > factor fill ratio given 1., needed 1. > Factored matrix follows: > Mat Object: 1 MPI processes > type: seqaij > rows=75, cols=75 > package used to perform factorization: petsc > total: nonzeros=927, allocated nonzeros=927 > total number of mallocs used during MatSetValues calls =0 > not using I-node routines > linear system matrix = precond matrix: > Mat Object: 1 MPI processes > type: seqaijviennacl > rows=75, cols=75 > total: nonzeros=927, allocated nonzeros=1335 > total number of mallocs used during MatSetValues calls =84 > not using I-node routines > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaijviennacl > rows=125, cols=125 > total: nonzeros=1685, allocated nonzeros=2885 > total number of mallocs used during MatSetValues calls =184 > has attached near null space > Press_Max: 1.9995807630564922E-004 > > > This is what we want, right? > > Still if i try using pc_type saviennacl directly it breaks, > > Thanks for your help i'll try my speedup like this, > > > > > > On Wed, Aug 29, 2018 at 2:21 PM, Manuel Valera wrote: > Ok, executing with: > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view > > > I get: > > > SETTING GPU TYPES > Matrix type: mpiaijviennacl > Of sizes: 125 x 125 > Matrix type: mpiaijviennacl > Of sizes: 125 x 125 > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Currently only handles ViennaCL matrices > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 14:20:42 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > [1]PETSC ERROR: ------------------------------------------------------------------------ > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 14:20:42 2018 > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > -------------------------------------------------------------------------- > MPI_ABORT was invoked on rank 1 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. > -------------------------------------------------------------------------- > [0]PETSC ERROR: ------------------------------------------------------------------------ > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > [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. > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 /home/valera/petsc/src/sys/objects/tagm.c > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 /home/valera/petsc/src/sys/objects/inherit.c > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/is/interface/isreg.c > [0]PETSC ERROR: [0] ISCreateGeneral line 658 /home/valera/petsc/src/vec/is/is/impls/general/general.c > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Signal received > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 14:20:42 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > [node50:77836] 1 more process has sent help message help-mpi-api.txt / mpi-abort > [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. wrote: > Please send complete error message > > > > On Aug 29, 2018, at 3:40 PM, Manuel Valera wrote: > > > > Yeah, no sorry, i get the same error with -pc_type bjacobi -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" > > > > > > Thanks and let me know of any progress on this issue, > > > > > > > > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera wrote: > > Awesome, thanks! > > > > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. wrote: > > > > > > > On Aug 29, 2018, at 3:26 PM, Manuel Valera wrote: > > > > > > > > > > > > You may need to use just plain PCBJACOBI or PCASM for parallelism and then SAVIENNACL sequentially on each block. > > > > > > > > > Can you elaborate a little in how to do this? do you mean i can only use viennacl in serial at the moment or this is a suggestion of a workaround on how to make it work? > > > > -pc_type bjacobi -sub_pc_type SAVIENNACL > > > > This will run in parallel and utilize the GPU for each block of the preconditioner. > > > > Barry > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera wrote: > > > > > > > > Hi everyone, > > > > > > > > Thanks for your responses, i understand communicating on this way to this level of technicality can be hard, i still think we can work ways to solve this problem though, > > > > > > > > I can say the following at this point: > > > > > > > > ? Program works without issues in any other non-gpu preconditioner, just by calling -pc_type ### . > > > > ? Program works correctly with ViennaCL preconditioners with mpirun -n 1, that is on one processor. > > > > ? Program breaks with every ViennaCL preconditioner when attempting any more than 1 processors. > > > > ? I haven't tried other GPU preconditioners because ViennaCL gave the best performance in 1 processor before. > > > > ? I have made sure the matrix type is mpiaijviennacl as it is printed right before the error log. > > > > ? I am attaching what i think are the backtrace logs of the run with two cores, as i have limited experience with this kind of debugging, and i cannot make sense of what they say, please let me know if you need me to do something else. > > > > > > > > Current options i can think of are giving you permission to clone my model repo, or for you to guide me trough the process remotely, > > > > > > > > Thanks, > > > > > > > > .-.-.-.- > > > > > > > > > > > > The error i get is still: > > > > > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [0]PETSC ERROR: No support for this operation for this object type > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > [1]PETSC ERROR: ------------------------------------------------------------------------ > > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > > > > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > > > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > > > -------------------------------------------------------------------------- > > > > MPI_ABORT was invoked on rank 1 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. > > > > -------------------------------------------------------------------------- > > > > [0]PETSC ERROR: ------------------------------------------------------------------------ > > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > > > > [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. > > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 /home/valera/petsc/src/mat/utils/gcreate.c > > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [0]PETSC ERROR: Signal received > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file > > > > [node50:32783] 1 more process has sent help message help-mpi-api.txt / mpi-abort > > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > > > > > > > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp wrote: > > > > Hi Manuel, > > > > > > > > as Barry said, it is hard for us to provide any help without having a more complete picture of what is going on. > > > > > > > > The error you report seems to come from the AMG preconditioner in ViennaCL. This can have many origins. Do other preconditioners run without error? Can you run in a debugger and provide a complete backtrace? > > > > > > > > Thanks and best regards, > > > > Karli > > > > > > > > > > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: > > > > Talked too fast, > > > > > > > > After fixing that problem, i tried more than one mpi processor and got the following: > > > > > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [0]PETSC ERROR: No support for this operation for this object type > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [1]PETSC ERROR: ------------------------------------------------------------------------ > > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > > > > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > > > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > > > -------------------------------------------------------------------------- > > > > MPI_ABORT was invoked on rank 1 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. > > > > -------------------------------------------------------------------------- > > > > [0]PETSC ERROR: ------------------------------------------------------------------------ > > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > > > > [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. > > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 /home/valera/petsc/src/sys/objects/tagm.c > > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 /home/valera/petsc/src/sys/objects/inherit.c > > > > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/is/interface/isreg.c > > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 /home/valera/petsc/src/vec/is/is/impls/general/general.c > > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [0]PETSC ERROR: Signal received > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > > > > [node50:30582] 1 more process has sent help message help-mpi-api.txt / mpi-abort > > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > > > > > > > > > > > > > It is currently running in 1 mpi processor + GPU but i would like to call at least 16 mpi processors + GPU to do the rest of the data management who is not part of the main laplacian on the mpi and the laplacian solution on the GPU, is this currently possible? > > > > > > > > Thanks for your help, > > > > > > > > > > > > > > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > wrote: > > > > > > > > Ok, i found the culprit and we can close this thread, > > > > > > > > The problem was a missing variable for setting the maximum columns, > > > > which i deleted at some point without realizing. The error message > > > > was too ambiguous to catch this so i had to compare with a previous > > > > working version of the arguments of MatSetValues, it was evident then. > > > > > > > > Good news is that i can now set the values with the viennacl types too, > > > > > > > > Thanks for your kind help, > > > > > > > > Manuel > > > > > > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > > > 1) PetscMalloc() is never valid or needed in Fortran > > > > > > > > 2) there is no reason to use DMSetMatrixPreallocateOnly() > > > > just use DMCreateMatrix() assuming that using a DM (DMDA, > > > > DMPLEX, etc) is suitable for your problem. > > > > > > > > At this end we are totally guessing at what you are doing > > > > and so have little help we can provide. A simple, nonworking > > > > code that tries to do what you would need would help us a great > > > > deal in understanding that you are trying to do. > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > Matthew, PetscMalloc gives the same error, > > > > > > > > > > Barry, it would be very hard for me to get the code to a > > > > minimum working example, i guess all i need to understand is how > > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() instead > > > > of MatMPIAIJSetPreallocation() as we were doing before, is there > > > > a simple example who does this in Fortran? > > > > > > > > > > Is the PetscMalloc call needed? is 'call > > > > PetscMalloc(1,row,ierr)' a valid, compilable call to > > > > PetscMalloc? what other reason may there be for this error to > > > > happen ? > > > > > > > > > > Just remembering, that trying to setup the matrix with the > > > > MatAIJSetPreallocation() brings up an error to acknowledge the > > > > viennacl datatypes and that's why i'm trying to make this change > > > > on your recommendation, > > > > > > > > > > Thanks for your help, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > Send your code in a way we can compile and run it; it must > > > > be some simple issue that is hard to communicate in email. > > > > > > > > > > Barry > > > > > > > > > > > > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > > > Hello everyone, > > > > > > > > > > > > I just had time to work on this again, and checked the code > > > > for errors on the matrix entries, this is the exact code i was > > > > using for creating the matrix without > > > > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and > > > > it worked that way, but trying this way i get the same 'Column > > > > too large' error using any number at the column position of > > > > MatSetValues, > > > > > > > > > > > > I have set up my code to print the column argument (n) of > > > > MatSetValues and in this case is 7 (lower than 124), it still > > > > gives error, even entering a specific number in the MatSetValues > > > > column argument position gives the same error. > > > > > > > > > > > > So next i went back to ex.50 here: > > > > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html > > > > > > > > and it has a very similar structure except the PetscMalloc1() > > > > call, so i tried adding that and got: > > > > > > > > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined > > > > reference to `petscmalloc1_' > > > > > > > > > > > > Any ideas on this behaviour? > > > > > > > > > > > > Thanks so much, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > > > Column too large: col 10980 max 124 > > > > > > > > > > > > You need to check the code that is generating the matrix > > > > entries. The matrix has 124 columns but you are attempting to > > > > put a value at column 10980 > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > > > > > Thanks Matthew and Barry, > > > > > > > > > > > > > > Now my code looks like: > > > > > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > call MatSetUp(A,ierr) > > > > > > > [...] > > > > > > > call > > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > > [...] > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > > > And i get a different error, now is: > > > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > > > -------------------------------------------------------------- > > > > > > > [0]PETSC ERROR: Argument out of range > > > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > > > > > [0]PETSC ERROR: See > > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > > for > > > > trouble shooting. > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 > > > > by valera Wed Aug 15 19:40:00 2018 > > > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > > > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > > > > > Should be > > > > > > > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > > > > > > > and remove the rest. You need to set the type of Mat > > > > you want the DM to return BEFORE you create the matrix. > > > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > > > > > > > Ok thanks for clarifying that, i wasn't sure if there > > > > were different types, > > > > > > > > > > > > > > > > Here is a stripped down version of my code, it seems > > > > like the preallocation is working now since the matrix > > > > population part is working without problem, but here it is for > > > > illustration purposes: > > > > > > > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > > call > > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > call MatSetUp(A,ierr) > > > > > > > > [...] > > > > > > > > call > > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > > > [...] > > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > > > > > Adding the first line there did the trick, > > > > > > > > > > > > > > > > Now the problem seems to be the program is not > > > > recognizing the matrix as ViennaCL type when i try with more > > > > than one processor, i get now: > > > > > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > > > -------------------------------------------------------------- > > > > > > > > [0]PETSC ERROR: No support for this operation for this > > > > object type > > > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > > > > > [0]PETSC ERROR: See > > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > > for > > > > trouble shooting. > > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > > > node50 by valera Wed Aug 15 14:44:22 2018 > > > > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > > > > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > > > > > > > > > When running with: > > > > > > > > > > > > > > > > mpirun -n 1 ./gcmLEP.GPU > > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > > > > > wrote: > > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > > > > > wrote: > > > > > > > > It seems to be resumed on: I do not know how to > > > > preallocate a DM Matrix correctly. > > > > > > > > > > > > > > > > There is only one matrix type, Mat. There are no > > > > separate DM matrices. A DM can create a matrix for you > > > > > > > > using DMCreateMatrix(), but that is a Mat and it is > > > > preallocated correctly. I am not sure what you are doing. > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > > > The interesting part is that it only breaks when i need > > > > to populate a GPU matrix from MPI, so kudos on that, but it > > > > seems i need to do better on my code to get this setup working, > > > > > > > > > > > > > > > > Any help would be appreciated, > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > > > > > wrote: > > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > > > > > wrote: > > > > > > > > Thanks Matthew, > > > > > > > > > > > > > > > > I try to do that when calling: > > > > > > > > > > > > > > > > call > > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > > > > > > > > > But i am not aware on how to do this for the DM if it > > > > needs something more specific/different, > > > > > > > > > > > > > > > > The error says that your preallocation is wrong for the > > > > values you are putting in. The DM does not control either, > > > > > > > > so I do not understand your email. > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > > > > > wrote: > > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > > > > > wrote: > > > > > > > > Hello PETSc devs, > > > > > > > > > > > > > > > > I am running into an error when trying to use the > > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs > > > > for MATSEQAIJVIENNACL type in one processor. The error happens > > > > when calling MatSetValues for this specific configuration. It > > > > does not occur when using MPI DMMatrix types only. > > > > > > > > > > > > > > > > The DM properly preallocates the matrix. I am assuming > > > > you do not here. > > > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > > > Any help will be appreciated, > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > My program call: > > > > > > > > > > > > > > > > mpirun -n 2 ./gcmLEP.GPU > > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > > > > > > > > > [1]PETSC ERROR: --------------------- Error Message > > > > -------------------------------------------------------------- > > > > > > > > [1]PETSC ERROR: Argument out of range > > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global > > > > row/column (75, 50) into matrix > > > > > > > > [1]PETSC ERROR: See > > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > > for > > > > trouble shooting. > > > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: > > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > > > node50 by valera Wed Aug 15 13:10:44 2018 > > > > > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > > > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > > > > > > > My Code structure: > > > > > > > > > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > > > > > > if (numprocs > 1) then ! set matrix type parallel > > > > > > > > ! Get local size > > > > > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > > > > > call VecDestroy(Tmpnat,ierr) > > > > > > > > ! Set matrix > > > > > > > > #ifdef GPU > > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > > print*,'SETTING GPU TYPES' > > > > > > > > #else > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > > > > > > #endif > > > > > > > > call > > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > else ! set matrix type sequential > > > > > > > > #ifdef GPU > > > > > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > > > > > print*,'SETTING GPU TYPES' > > > > > > > > #else > > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) > > > > > > > > #endif > > > > > > > > call MatSetUp(A,ierr) > > > > > > > > call > > > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > > > > > > > > > do k=zstart,zend-1 > > > > > > > > do j=ystart,yend-1 > > > > > > > > do i=xstart,xend-1 > > > > > > > > [..] > > > > > > > > call > > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > > 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 > > > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > > 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 > > > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > > 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 > > > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > From bsmith at mcs.anl.gov Wed Aug 29 17:59:22 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Wed, 29 Aug 2018 22:59:22 +0000 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: <63242495-2817-4BF3-B9A6-30679B74EBE0@mcs.anl.gov> Based on the error messages I think you are not calling KSPSetFromOptions (or SNESSetFromOptions if using SNES) from your code therefor the options -pc_type bjacobi -pc_sub_type saviennacl are ignored and it is still trying to do the parallel saviennacl which is not supported. Barry > On Aug 29, 2018, at 4:21 PM, Manuel Valera wrote: > > Ok, executing with: > > mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view > > > I get: > > > SETTING GPU TYPES > Matrix type: mpiaijviennacl > Of sizes: 125 x 125 > Matrix type: mpiaijviennacl > Of sizes: 125 x 125 > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: No support for this operation for this object type > [0]PETSC ERROR: Currently only handles ViennaCL matrices > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 14:20:42 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > [1]PETSC ERROR: ------------------------------------------------------------------------ > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 14:20:42 2018 > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > -------------------------------------------------------------------------- > MPI_ABORT was invoked on rank 1 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. > -------------------------------------------------------------------------- > [0]PETSC ERROR: ------------------------------------------------------------------------ > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > [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. > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 /home/valera/petsc/src/sys/objects/tagm.c > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 /home/valera/petsc/src/sys/objects/inherit.c > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/is/interface/isreg.c > [0]PETSC ERROR: [0] ISCreateGeneral line 658 /home/valera/petsc/src/vec/is/is/impls/general/general.c > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Signal received > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 14:20:42 2018 > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > [node50:77836] 1 more process has sent help message help-mpi-api.txt / mpi-abort > [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. wrote: > Please send complete error message > > > > On Aug 29, 2018, at 3:40 PM, Manuel Valera wrote: > > > > Yeah, no sorry, i get the same error with -pc_type bjacobi -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" > > > > > > Thanks and let me know of any progress on this issue, > > > > > > > > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera wrote: > > Awesome, thanks! > > > > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. wrote: > > > > > > > On Aug 29, 2018, at 3:26 PM, Manuel Valera wrote: > > > > > > > > > > > > You may need to use just plain PCBJACOBI or PCASM for parallelism and then SAVIENNACL sequentially on each block. > > > > > > > > > Can you elaborate a little in how to do this? do you mean i can only use viennacl in serial at the moment or this is a suggestion of a workaround on how to make it work? > > > > -pc_type bjacobi -sub_pc_type SAVIENNACL > > > > This will run in parallel and utilize the GPU for each block of the preconditioner. > > > > Barry > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera wrote: > > > > > > > > Hi everyone, > > > > > > > > Thanks for your responses, i understand communicating on this way to this level of technicality can be hard, i still think we can work ways to solve this problem though, > > > > > > > > I can say the following at this point: > > > > > > > > ? Program works without issues in any other non-gpu preconditioner, just by calling -pc_type ### . > > > > ? Program works correctly with ViennaCL preconditioners with mpirun -n 1, that is on one processor. > > > > ? Program breaks with every ViennaCL preconditioner when attempting any more than 1 processors. > > > > ? I haven't tried other GPU preconditioners because ViennaCL gave the best performance in 1 processor before. > > > > ? I have made sure the matrix type is mpiaijviennacl as it is printed right before the error log. > > > > ? I am attaching what i think are the backtrace logs of the run with two cores, as i have limited experience with this kind of debugging, and i cannot make sense of what they say, please let me know if you need me to do something else. > > > > > > > > Current options i can think of are giving you permission to clone my model repo, or for you to guide me trough the process remotely, > > > > > > > > Thanks, > > > > > > > > .-.-.-.- > > > > > > > > > > > > The error i get is still: > > > > > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [0]PETSC ERROR: No support for this operation for this object type > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > [1]PETSC ERROR: ------------------------------------------------------------------------ > > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > > > > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > > > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [1]PETSC ERROR: [1] KSPSetUp line 294 /home/valera/petsc/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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > > > -------------------------------------------------------------------------- > > > > MPI_ABORT was invoked on rank 1 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. > > > > -------------------------------------------------------------------------- > > > > [0]PETSC ERROR: ------------------------------------------------------------------------ > > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > > > > [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. > > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 /home/valera/petsc/src/mat/utils/gcreate.c > > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [0]PETSC ERROR: [0] KSPSetUp line 294 /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [0]PETSC ERROR: Signal received > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed Aug 29 11:43:25 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown file > > > > [node50:32783] 1 more process has sent help message help-mpi-api.txt / mpi-abort > > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > > > > > > > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp wrote: > > > > Hi Manuel, > > > > > > > > as Barry said, it is hard for us to provide any help without having a more complete picture of what is going on. > > > > > > > > The error you report seems to come from the AMG preconditioner in ViennaCL. This can have many origins. Do other preconditioners run without error? Can you run in a debugger and provide a complete backtrace? > > > > > > > > Thanks and best regards, > > > > Karli > > > > > > > > > > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: > > > > Talked too fast, > > > > > > > > After fixing that problem, i tried more than one mpi processor and got the following: > > > > > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > > Matrix type: mpiaijviennacl > > > > Of sizes: 125 x 125 > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [0]PETSC ERROR: No support for this operation for this object type > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [1]PETSC ERROR: ------------------------------------------------------------------------ > > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, probably memory access out of range > > > > [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] PetscTraceBackErrorHandler line 182 /home/valera/petsc/src/sys/error/errtrace.c > > > > [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/error/err.c > > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > > > > [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown file > > > > -------------------------------------------------------------------------- > > > > MPI_ABORT was invoked on rank 1 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. > > > > -------------------------------------------------------------------------- > > > > [0]PETSC ERROR: ------------------------------------------------------------------------ > > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the batch system) has told this process to end > > > > [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. > > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 /home/valera/petsc/src/sys/objects/tagm.c > > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 /home/valera/petsc/src/sys/objects/inherit.c > > > > [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/is/interface/isreg.c > > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 /home/valera/petsc/src/vec/is/is/impls/general/general.c > > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > > > [0]PETSC ERROR: Signal received > > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Tue Aug 28 16:30:02 2018 > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown file > > > > [node50:30582] 1 more process has sent help message help-mpi-api.txt / mpi-abort > > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 to see all help / error messages > > > > > > > > > > > > > > > > It is currently running in 1 mpi processor + GPU but i would like to call at least 16 mpi processors + GPU to do the rest of the data management who is not part of the main laplacian on the mpi and the laplacian solution on the GPU, is this currently possible? > > > > > > > > Thanks for your help, > > > > > > > > > > > > > > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera > wrote: > > > > > > > > Ok, i found the culprit and we can close this thread, > > > > > > > > The problem was a missing variable for setting the maximum columns, > > > > which i deleted at some point without realizing. The error message > > > > was too ambiguous to catch this so i had to compare with a previous > > > > working version of the arguments of MatSetValues, it was evident then. > > > > > > > > Good news is that i can now set the values with the viennacl types too, > > > > > > > > Thanks for your kind help, > > > > > > > > Manuel > > > > > > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > > > 1) PetscMalloc() is never valid or needed in Fortran > > > > > > > > 2) there is no reason to use DMSetMatrixPreallocateOnly() > > > > just use DMCreateMatrix() assuming that using a DM (DMDA, > > > > DMPLEX, etc) is suitable for your problem. > > > > > > > > At this end we are totally guessing at what you are doing > > > > and so have little help we can provide. A simple, nonworking > > > > code that tries to do what you would need would help us a great > > > > deal in understanding that you are trying to do. > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > Matthew, PetscMalloc gives the same error, > > > > > > > > > > Barry, it would be very hard for me to get the code to a > > > > minimum working example, i guess all i need to understand is how > > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() instead > > > > of MatMPIAIJSetPreallocation() as we were doing before, is there > > > > a simple example who does this in Fortran? > > > > > > > > > > Is the PetscMalloc call needed? is 'call > > > > PetscMalloc(1,row,ierr)' a valid, compilable call to > > > > PetscMalloc? what other reason may there be for this error to > > > > happen ? > > > > > > > > > > Just remembering, that trying to setup the matrix with the > > > > MatAIJSetPreallocation() brings up an error to acknowledge the > > > > viennacl datatypes and that's why i'm trying to make this change > > > > on your recommendation, > > > > > > > > > > Thanks for your help, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > Send your code in a way we can compile and run it; it must > > > > be some simple issue that is hard to communicate in email. > > > > > > > > > > Barry > > > > > > > > > > > > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > > > Hello everyone, > > > > > > > > > > > > I just had time to work on this again, and checked the code > > > > for errors on the matrix entries, this is the exact code i was > > > > using for creating the matrix without > > > > DMSetMatrixPreallocateOnly, using MatMPIAIJSetPreallocation and > > > > it worked that way, but trying this way i get the same 'Column > > > > too large' error using any number at the column position of > > > > MatSetValues, > > > > > > > > > > > > I have set up my code to print the column argument (n) of > > > > MatSetValues and in this case is 7 (lower than 124), it still > > > > gives error, even entering a specific number in the MatSetValues > > > > column argument position gives the same error. > > > > > > > > > > > > So next i went back to ex.50 here: > > > > http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html > > > > > > > > and it has a very similar structure except the PetscMalloc1() > > > > call, so i tried adding that and got: > > > > > > > > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined > > > > reference to `petscmalloc1_' > > > > > > > > > > > > Any ideas on this behaviour? > > > > > > > > > > > > Thanks so much, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > > > Column too large: col 10980 max 124 > > > > > > > > > > > > You need to check the code that is generating the matrix > > > > entries. The matrix has 124 columns but you are attempting to > > > > put a value at column 10980 > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > > > > > Thanks Matthew and Barry, > > > > > > > > > > > > > > Now my code looks like: > > > > > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > call MatSetUp(A,ierr) > > > > > > > [...] > > > > > > > call > > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > > [...] > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > > > And i get a different error, now is: > > > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > > > -------------------------------------------------------------- > > > > > > > [0]PETSC ERROR: Argument out of range > > > > > > > [0]PETSC ERROR: Column too large: col 10980 max 124 > > > > > > > [0]PETSC ERROR: See > > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > > for > > > > trouble shooting. > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 > > > > by valera Wed Aug 15 19:40:00 2018 > > > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 in > > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c > > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in > > > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > > > > Thanks again, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. > > > > > wrote: > > > > > > > > > > > > > > Should be > > > > > > > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > > > > > > > and remove the rest. You need to set the type of Mat > > > > you want the DM to return BEFORE you create the matrix. > > > > > > > > > > > > > > Barry > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera > > > > > wrote: > > > > > > > > > > > > > > > > Ok thanks for clarifying that, i wasn't sure if there > > > > were different types, > > > > > > > > > > > > > > > > Here is a stripped down version of my code, it seems > > > > like the preallocation is working now since the matrix > > > > population part is working without problem, but here it is for > > > > illustration purposes: > > > > > > > > > > > > > > > > call DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > > call > > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > call MatSetUp(A,ierr) > > > > > > > > [...] > > > > > > > > call > > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > > > [...] > > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) > > > > > > > > > > > > > > > > Adding the first line there did the trick, > > > > > > > > > > > > > > > > Now the problem seems to be the program is not > > > > recognizing the matrix as ViennaCL type when i try with more > > > > than one processor, i get now: > > > > > > > > > > > > > > > > [0]PETSC ERROR: --------------------- Error Message > > > > -------------------------------------------------------------- > > > > > > > > [0]PETSC ERROR: No support for this operation for this > > > > object type > > > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices > > > > > > > > [0]PETSC ERROR: See > > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > > for > > > > trouble shooting. > > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: > > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > > > node50 by valera Wed Aug 15 14:44:22 2018 > > > > > > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in > > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu > > > > > > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in > > > > /home/valera/petsc/src/ksp/pc/interface/precon.c > > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in > > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c > > > > > > > > > > > > > > > > When running with: > > > > > > > > > > > > > > > > mpirun -n 1 ./gcmLEP.GPU > > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley > > > > > wrote: > > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera > > > > > wrote: > > > > > > > > It seems to be resumed on: I do not know how to > > > > preallocate a DM Matrix correctly. > > > > > > > > > > > > > > > > There is only one matrix type, Mat. There are no > > > > separate DM matrices. A DM can create a matrix for you > > > > > > > > using DMCreateMatrix(), but that is a Mat and it is > > > > preallocated correctly. I am not sure what you are doing. > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > > > The interesting part is that it only breaks when i need > > > > to populate a GPU matrix from MPI, so kudos on that, but it > > > > seems i need to do better on my code to get this setup working, > > > > > > > > > > > > > > > > Any help would be appreciated, > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley > > > > > wrote: > > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera > > > > > wrote: > > > > > > > > Thanks Matthew, > > > > > > > > > > > > > > > > I try to do that when calling: > > > > > > > > > > > > > > > > call > > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > > > > > > > > > But i am not aware on how to do this for the DM if it > > > > needs something more specific/different, > > > > > > > > > > > > > > > > The error says that your preallocation is wrong for the > > > > values you are putting in. The DM does not control either, > > > > > > > > so I do not understand your email. > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley > > > > > wrote: > > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera > > > > > wrote: > > > > > > > > Hello PETSc devs, > > > > > > > > > > > > > > > > I am running into an error when trying to use the > > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same code runs > > > > for MATSEQAIJVIENNACL type in one processor. The error happens > > > > when calling MatSetValues for this specific configuration. It > > > > does not occur when using MPI DMMatrix types only. > > > > > > > > > > > > > > > > The DM properly preallocates the matrix. I am assuming > > > > you do not here. > > > > > > > > > > > > > > > > Matt > > > > > > > > > > > > > > > > Any help will be appreciated, > > > > > > > > > > > > > > > > Thanks, > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > My program call: > > > > > > > > > > > > > > > > mpirun -n 2 ./gcmLEP.GPU > > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 > > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type aijviennacl > > > > -pc_type saviennacl -log_view > > > > > > > > > > > > > > > > > > > > > > > > The error (repeats after each MatSetValues call): > > > > > > > > > > > > > > > > [1]PETSC ERROR: --------------------- Error Message > > > > -------------------------------------------------------------- > > > > > > > > [1]PETSC ERROR: Argument out of range > > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at global > > > > row/column (75, 50) into matrix > > > > > > > > [1]PETSC ERROR: See > > > > http://www.mcs.anl.gov/petsc/documentation/faq.html > > > > for > > > > trouble shooting. > > > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: > > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 > > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named > > > > node50 by valera Wed Aug 15 13:10:44 2018 > > > > > > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug > > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 > > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 > > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 > > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl > > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line 608 in > > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c > > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in > > > > /home/valera/petsc/src/mat/interface/matrix.c > > > > > > > > > > > > > > > > > > > > > > > > My Code structure: > > > > > > > > > > > > > > > > call DMCreateMatrix(daDummy,A,ierr) > > > > > > > > call MatSetFromOptions(A,ierr) > > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, ierr) > > > > > > > > if (numprocs > 1) then ! set matrix type parallel > > > > > > > > ! Get local size > > > > > > > > call DMDACreateNaturalVector(daDummy,Tmpnat,ierr) > > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) > > > > > > > > call VecDestroy(Tmpnat,ierr) > > > > > > > > ! Set matrix > > > > > > > > #ifdef GPU > > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) > > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) > > > > > > > > print*,'SETTING GPU TYPES' > > > > > > > > #else > > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) > > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) > > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! > > > > > > > > #endif > > > > > > > > call > > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) > > > > > > > > else ! set matrix type sequential > > > > > > > > #ifdef GPU > > > > > > > > call DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) > > > > > > > > call DMSetVecType(daDummy,VECSEQVIENNACL,ierr) > > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) > > > > > > > > print*,'SETTING GPU TYPES' > > > > > > > > #else > > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) > > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) > > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) > > > > > > > > #endif > > > > > > > > call MatSetUp(A,ierr) > > > > > > > > call > > > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) > > > > > > > > > > > > > > > > do k=zstart,zend-1 > > > > > > > > do j=ystart,yend-1 > > > > > > > > do i=xstart,xend-1 > > > > > > > > [..] > > > > > > > > call > > > > MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) > > > > > > > > [..] > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > > 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 > > > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > > 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 > > > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > -- > > > > > > > > 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 > > > > > > > > > > > > > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > > From srahul_05 at yahoo.co.in Wed Aug 29 23:37:30 2018 From: srahul_05 at yahoo.co.in (Rahul Samala) Date: Thu, 30 Aug 2018 04:37:30 +0000 (UTC) Subject: [petsc-users] Problem with SNES convergence In-Reply-To: <387994F6-79FF-4DE4-8375-B24F63B0F332@anl.gov> References: <1371398831.496454.1535553418412.ref@mail.yahoo.com> <1371398831.496454.1535553418412@mail.yahoo.com> <387994F6-79FF-4DE4-8375-B24F63B0F332@anl.gov> Message-ID: <1135178798.714456.1535603850997@mail.yahoo.com> Thank you Ling, I would definitely like to look at your code for reducing timestep size.Thank you Barry for your inputs. --Rahul. On Wednesday, August 29, 2018, 9:02:00 PM GMT+5:30, Smith, Barry F. wrote: Current time (before start of timestep) 52.5048,??? iter=5380 ??? Timestep=864.000000 ? 0 SNES Function norm 1.650467412595e+05 ? ? 0 KSP preconditioned resid norm 3.979123221160e+03 true resid norm 1.650467412595e+05 ||r(i)||/||b|| 1.000000000000e+00 ? ? 1 KSP preconditioned resid norm 9.178246525982e-11 true resid norm 7.006473307032e-09 ||r(i)||/||b|| 4.245144892632e-14 ? Linear solve converged due to CONVERGED_RTOL iterations 1 ? 1 SNES Function norm 6.722712947273e+02 ? Linear solve did not converge due to DIVERGED_NANORINF iterations 0 Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 1 ? ? This usually is an indicator that the LU (ILU) factorization has hit a zero pivot (hence the linear solve has a divide by zero so gives the DIVERGED_NANORINF flag). ? ? You can/should call SNESGetConvergedReason() immediately after each SNESSolve(), if the result is negative that means something has failed in the nonlinear solve and you can try cutting the time-step and trying again. ? ? Good luck, ? ? Barry > On Aug 29, 2018, at 10:11 AM, Ling Zou wrote: > > 1) My experience is that this kind of bug or sudden death (everything is fine till suddenly something is broken) is very difficult to debug/fix. I looked at your txt files and could not give any quick comments. Maybe PETSc developers have better idea on this. > 2) I do have successful experience on reducing time step size when PETSc fails solving or my own piece of code throws an exception. If you are interested, I can share them. > > -Ling > From: petsc-users on behalf of Rahul Samala > Sent: Wednesday, August 29, 2018 8:36:58 AM > To: PETSc Users List > Subject: [petsc-users] Problem with SNES convergence >? > Hello PetSc users, > > 1)? I have problem with SNES convergence. I call SNESSolve? in a time loop and use the inbuilt Jacobian feature. The code works fine for about 5380 time steps after which it breaks down. The solution till that point looks fine. I have used newtonls of type l2. (newtontr and others aren't working). Since I have used inbuilt Jacobian feature and the code worked for about 5000 time steps I don't understand the reason for failure, is it an incorrect function evaluation?? Attached are the outputs with -pc_type lu and ilu along with -snes_linesearch_type l2 -snes_converged_reason -snes_monitor -snes_view -ksp_converged_reason -ksp_monitor_true_residual > > 2)? How to get hold of failure signal, like Nonlinear solve DIVERGED_MAX_IT or DIVERGED_LINEAR_SOLVE so that whenever it occurs I can use a reduced time step and see if the code converges. > > Thank you, > Rahul. > > output_ilu.txt > > ??? > output_ilu.txt > > > > output_lu.txt > > ??? > output_lu.txt -------------- next part -------------- An HTML attachment was scrubbed... URL: From yjwu16 at gmail.com Thu Aug 30 03:09:23 2018 From: yjwu16 at gmail.com (Yingjie Wu) Date: Thu, 30 Aug 2018 16:09:23 +0800 Subject: [petsc-users] Questions about x-window and matlab engine in PETSc Message-ID: Dear PETSc developer, Hi, Thank you very much for helping me solve the problem before. Recently, I reinstalled my system and reinstalled PETSc and found the following problems: 1. when I ran the example src/vec/vec/example/tutorial/ex3, there was a error: [0] PETSC ERROR: PETSc installed without X windows, Microsoft Graphics, OpenGL ES, or GLUT / OpenGL on this machine I installed PETSc following the official website. I don't know how to solve this error. 2. I want to use matlab to do input and output data. My data is mainly the information of model parameters and initial values in each grid, which is usually stored in the form of matrix or vector. In src / vec / vec / example / tutorial / ex5, the input and output data in the binary file. dat, but I don't know how to open it for subsequent analysis. I want to input or output data to PETSc in the form of matrix and vector in MATLAB. I don't know how to use MATLAB as the input and output interface. It would be better if there were examples. 3. Is there a web page that can query the usage of PETSc function? For example, Http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Viewer/PetscViewerBinaryOpen.html For beginners like me, a web page that queries how functions are used is very useful. Thanks, Yingjie -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Thu Aug 30 05:10:18 2018 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 30 Aug 2018 06:10:18 -0400 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: On Wed, Aug 29, 2018 at 6:21 PM Manuel Valera wrote: > I understand that Matthew, thanks, > > I am trying to see if i get any speedup in this configuration, otherwise i > will be waiting for the MPIAIJ support on PETSc, > > Is there any other gpu preconditioner that works on parallel matrices > directly? > Not that I know of . Such a hypothetical preconditioner would need to pass information back and forth, across the PCI bus, and then through MPI (even if you imagine direct GPU-GPU communication, it still hits the PCI bus). This channel has small bandwidth, but even more limiting is the high latency. Its unclear what kind of algorithm would do well in this situation. Thanks, Matt > Thanks again, > > > > On Wed, Aug 29, 2018 at 3:05 PM, Matthew Knepley > wrote: > >> On Wed, Aug 29, 2018 at 5:49 PM Manuel Valera wrote: >> >>> Update: >>> >>> I made it work like you suggested Barry, i had to comment the code line >>> to set up the pc_type saviennacl, that way i am getting as ksp_view: >>> >>> KSP Object: 2 MPI processes >>> type: cg >>> maximum iterations=10000, initial guess is zero >>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>> left preconditioning >>> using PRECONDITIONED norm type for convergence test >>> PC Object: 2 MPI processes >>> type: bjacobi >>> number of blocks = 2 >>> Local solve is same for all blocks, in the following KSP and PC >>> objects: >>> KSP Object: (sub_) 1 MPI processes >>> type: preonly >>> maximum iterations=10000, initial guess is zero >>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. >>> left preconditioning >>> using NONE norm type for convergence test >>> PC Object: (sub_) 1 MPI processes >>> type: ilu >>> out-of-place factorization >>> 0 levels of fill >>> tolerance for zero pivot 2.22045e-14 >>> matrix ordering: natural >>> factor fill ratio given 1., needed 1. >>> Factored matrix follows: >>> Mat Object: 1 MPI processes >>> type: seqaij >>> rows=75, cols=75 >>> package used to perform factorization: petsc >>> total: nonzeros=927, allocated nonzeros=927 >>> total number of mallocs used during MatSetValues calls =0 >>> not using I-node routines >>> linear system matrix = precond matrix: >>> Mat Object: 1 MPI processes >>> type: seqaijviennacl >>> rows=75, cols=75 >>> total: nonzeros=927, allocated nonzeros=1335 >>> total number of mallocs used during MatSetValues calls =84 >>> not using I-node routines >>> linear system matrix = precond matrix: >>> Mat Object: 2 MPI processes >>> type: mpiaijviennacl >>> rows=125, cols=125 >>> total: nonzeros=1685, allocated nonzeros=2885 >>> total number of mallocs used during MatSetValues calls =184 >>> has attached near null space >>> Press_Max: 1.9995807630564922E-004 >>> >>> >>> This is what we want, right? >>> >>> Still if i try using pc_type saviennacl directly it breaks, >>> >> >> You are missing the point of the error message. >> >> We do not support SAVIENNACL on parallel matrices (MPIAIJ). We do support >> it >> on serial matrices (SEQAIJ). When you are setting in directly, you are >> applying it >> to a parallel matrix. If you use Block-Jacobi, you are applying it to >> each submatrix, >> and those submatrices are all serial. >> >> Thanks, >> >> Matt >> >> >>> Thanks for your help i'll try my speedup like this, >>> >>> >>> >>> >>> >>> On Wed, Aug 29, 2018 at 2:21 PM, Manuel Valera >>> wrote: >>> >>>> Ok, executing with: >>>> >>>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>>> jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view >>>> >>>> >>>> I get: >>>> >>>> >>>> SETTING GPU TYPES >>>> Matrix type: mpiaijviennacl >>>> >>>> Of sizes: 125 x 125 >>>> Matrix type: mpiaijviennacl >>>> >>>> Of sizes: 125 x 125 >>>> [0]PETSC ERROR: --------------------- Error Message >>>> -------------------------------------------------------------- >>>> [0]PETSC ERROR: No support for this operation for this object type >>>> [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >>>> for trouble shooting. >>>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 >>>> GIT Date: 2018-08-29 12:42:36 -0600 >>>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >>>> Aug 29 14:20:42 2018 >>>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc >>>> --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>> --download-viennacl --download-cusp >>>> [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>> [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>> [1]PETSC ERROR: >>>> ------------------------------------------------------------------------ >>>> [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, >>>> probably memory access out of range >>>> [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] PetscTraceBackErrorHandler line 182 >>>> /home/valera/petsc/src/sys/error/errtrace.c >>>> [1]PETSC ERROR: [1] PetscError line 352 >>>> /home/valera/petsc/src/sys/error/err.c >>>> [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>> [1]PETSC ERROR: [1] PCSetUp line 894 >>>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.3-1264-g6fb0cd4 >>>> GIT Date: 2018-08-29 12:42:36 -0600 >>>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >>>> Aug 29 14:20:42 2018 >>>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc >>>> --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>> --download-viennacl --download-cusp >>>> [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >>>> >>>> -------------------------------------------------------------------------- >>>> MPI_ABORT was invoked on rank 1 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. >>>> >>>> -------------------------------------------------------------------------- >>>> [0]PETSC ERROR: >>>> ------------------------------------------------------------------------ >>>> [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or the >>>> batch system) has told this process to end >>>> [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. >>>> [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>> /home/valera/petsc/src/sys/objects/tagm.c >>>> [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 >>>> /home/valera/petsc/src/sys/objects/inherit.c >>>> [0]PETSC ERROR: [0] ISCreate line 35 >>>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>>> [0]PETSC ERROR: [0] ISCreateGeneral line 658 >>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>> [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>> [0]PETSC ERROR: [0] PCSetUp line 894 >>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>> [0]PETSC ERROR: --------------------- Error Message >>>> -------------------------------------------------------------- >>>> [0]PETSC ERROR: Signal received >>>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html >>>> for trouble shooting. >>>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 >>>> GIT Date: 2018-08-29 12:42:36 -0600 >>>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera Wed >>>> Aug 29 14:20:42 2018 >>>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug --with-cc=mpicc >>>> --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 >>>> --download-viennacl --download-cusp >>>> [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >>>> [node50:77836] 1 more process has sent help message help-mpi-api.txt / >>>> mpi-abort >>>> [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to see >>>> all help / error messages >>>> >>>> >>>> >>>> On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. >>>> wrote: >>>> >>>>> Please send complete error message >>>>> >>>>> >>>>> > On Aug 29, 2018, at 3:40 PM, Manuel Valera >>>>> wrote: >>>>> > >>>>> > Yeah, no sorry, i get the same error with -pc_type bjacobi >>>>> -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" >>>>> > >>>>> > >>>>> > Thanks and let me know of any progress on this issue, >>>>> > >>>>> > >>>>> > >>>>> > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera >>>>> wrote: >>>>> > Awesome, thanks! >>>>> > >>>>> > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. >>>>> wrote: >>>>> > >>>>> > >>>>> > > On Aug 29, 2018, at 3:26 PM, Manuel Valera >>>>> wrote: >>>>> > > >>>>> > > >>>>> > > >>>>> > > You may need to use just plain PCBJACOBI or PCASM for parallelism >>>>> and then SAVIENNACL sequentially on each block. >>>>> > > >>>>> > > >>>>> > > Can you elaborate a little in how to do this? do you mean i can >>>>> only use viennacl in serial at the moment or this is a suggestion of a >>>>> workaround on how to make it work? >>>>> > >>>>> > -pc_type bjacobi -sub_pc_type SAVIENNACL >>>>> > >>>>> > This will run in parallel and utilize the GPU for each block of >>>>> the preconditioner. >>>>> > >>>>> > Barry >>>>> > >>>>> > > >>>>> > > >>>>> > > Thanks, >>>>> > > >>>>> > > >>>>> > > >>>>> > > >>>>> > > >>>>> > > >>>>> > > >>>>> > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera >>>>> wrote: >>>>> > > > >>>>> > > > Hi everyone, >>>>> > > > >>>>> > > > Thanks for your responses, i understand communicating on this >>>>> way to this level of technicality can be hard, i still think we can work >>>>> ways to solve this problem though, >>>>> > > > >>>>> > > > I can say the following at this point: >>>>> > > > >>>>> > > > ? Program works without issues in any other non-gpu >>>>> preconditioner, just by calling -pc_type ### . >>>>> > > > ? Program works correctly with ViennaCL preconditioners >>>>> with mpirun -n 1, that is on one processor. >>>>> > > > ? Program breaks with every ViennaCL preconditioner when >>>>> attempting any more than 1 processors. >>>>> > > > ? I haven't tried other GPU preconditioners because >>>>> ViennaCL gave the best performance in 1 processor before. >>>>> > > > ? I have made sure the matrix type is mpiaijviennacl as it >>>>> is printed right before the error log. >>>>> > > > ? I am attaching what i think are the backtrace logs of >>>>> the run with two cores, as i have limited experience with this kind of >>>>> debugging, and i cannot make sense of what they say, please let me know if >>>>> you need me to do something else. >>>>> > > > >>>>> > > > Current options i can think of are giving you permission to >>>>> clone my model repo, or for you to guide me trough the process remotely, >>>>> > > > >>>>> > > > Thanks, >>>>> > > > >>>>> > > > .-.-.-.- >>>>> > > > >>>>> > > > >>>>> > > > The error i get is still: >>>>> > > > >>>>> > > > Matrix type: mpiaijviennacl >>>>> >>>>> > > > Of sizes: 125 x 125 >>>>> > > > Matrix type: mpiaijviennacl >>>>> >>>>> > > > Of sizes: 125 x 125 >>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>> -------------------------------------------------------------- >>>>> > > > [0]PETSC ERROR: No support for this operation for this object >>>>> type >>>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>> > > > [0]PETSC ERROR: See >>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>> shooting. >>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>> valera Wed Aug 29 11:43:25 2018 >>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>> > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>> > > > [1]PETSC ERROR: >>>>> ------------------------------------------------------------------------ >>>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>> Violation, probably memory access out of range >>>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>>> /home/valera/petsc/src/sys/error/err.c >>>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>> > > > [1]PETSC ERROR: [1] KSPSetUp line 294 >>>>> /home/valera/petsc/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 Development GIT revision: >>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>> valera Wed Aug 29 11:43:25 2018 >>>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown >>>>> file >>>>> > > > >>>>> -------------------------------------------------------------------------- >>>>> > > > MPI_ABORT was invoked on rank 1 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. >>>>> > > > >>>>> -------------------------------------------------------------------------- >>>>> > > > [0]PETSC ERROR: >>>>> ------------------------------------------------------------------------ >>>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process >>>>> (or the batch system) has told this process to end >>>>> > > > [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. >>>>> > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 >>>>> /home/valera/petsc/src/mat/utils/gcreate.c >>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>> > > > [0]PETSC ERROR: [0] KSPSetUp line 294 >>>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>> -------------------------------------------------------------- >>>>> > > > [0]PETSC ERROR: Signal received >>>>> > > > [0]PETSC ERROR: See >>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>> shooting. >>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>> valera Wed Aug 29 11:43:25 2018 >>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>> > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown >>>>> file >>>>> > > > [node50:32783] 1 more process has sent help message >>>>> help-mpi-api.txt / mpi-abort >>>>> > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to 0 >>>>> to see all help / error messages >>>>> > > > >>>>> > > > >>>>> > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp < >>>>> rupp at iue.tuwien.ac.at> wrote: >>>>> > > > Hi Manuel, >>>>> > > > >>>>> > > > as Barry said, it is hard for us to provide any help without >>>>> having a more complete picture of what is going on. >>>>> > > > >>>>> > > > The error you report seems to come from the AMG preconditioner >>>>> in ViennaCL. This can have many origins. Do other preconditioners run >>>>> without error? Can you run in a debugger and provide a complete backtrace? >>>>> > > > >>>>> > > > Thanks and best regards, >>>>> > > > Karli >>>>> > > > >>>>> > > > >>>>> > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: >>>>> > > > Talked too fast, >>>>> > > > >>>>> > > > After fixing that problem, i tried more than one mpi processor >>>>> and got the following: >>>>> > > > >>>>> > > > Matrix type: mpiaijviennacl >>>>> > > > Of sizes: 125 x 125 >>>>> > > > Matrix type: mpiaijviennacl >>>>> > > > Of sizes: 125 x 125 >>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>> -------------------------------------------------------------- >>>>> > > > [0]PETSC ERROR: No support for this operation for this object >>>>> type >>>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>> > > > [0]PETSC ERROR: See >>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>> shooting. >>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>> valera Tue Aug 28 16:30:02 2018 >>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >>>>> http://saviennacl.cu> >>>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>> > > > [1]PETSC ERROR: >>>>> ------------------------------------------------------------------------ >>>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>> Violation, probably memory access out of range >>>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>>> /home/valera/petsc/src/sys/error/err.c >>>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>>> http://saviennacl.cu> >>>>> > > > >>>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: >>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>> valera Tue Aug 28 16:30:02 2018 >>>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown >>>>> file >>>>> > > > >>>>> -------------------------------------------------------------------------- >>>>> > > > MPI_ABORT was invoked on rank 1 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. >>>>> > > > >>>>> -------------------------------------------------------------------------- >>>>> > > > [0]PETSC ERROR: >>>>> ------------------------------------------------------------------------ >>>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process >>>>> (or the batch system) has told this process to end >>>>> > > > [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. >>>>> > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>>> /home/valera/petsc/src/sys/objects/tagm.c >>>>> > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >>>>> /home/valera/petsc/src/sys/objects/inherit.c >>>>> > > > [0]PETSC ERROR: [0] ISCreate line 35 >>>>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>>>> > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 >>>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>>> http://saviennacl.cu> >>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>> -------------------------------------------------------------- >>>>> > > > [0]PETSC ERROR: Signal received >>>>> > > > [0]PETSC ERROR: See >>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>> shooting. >>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>> valera Tue Aug 28 16:30:02 2018 >>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>> > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown >>>>> file >>>>> > > > [node50:30582] 1 more process has sent help message >>>>> help-mpi-api.txt / mpi-abort >>>>> > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to 0 >>>>> to see all help / error messages >>>>> > > > >>>>> > > > >>>>> > > > >>>>> > > > It is currently running in 1 mpi processor + GPU but i would >>>>> like to call at least 16 mpi processors + GPU to do the rest of the data >>>>> management who is not part of the main laplacian on the mpi and the >>>>> laplacian solution on the GPU, is this currently possible? >>>>> > > > >>>>> > > > Thanks for your help, >>>>> > > > >>>>> > > > >>>>> > > > >>>>> > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera < >>>>> mvalera-w at sdsu.edu > wrote: >>>>> > > > >>>>> > > > Ok, i found the culprit and we can close this thread, >>>>> > > > >>>>> > > > The problem was a missing variable for setting the maximum >>>>> columns, >>>>> > > > which i deleted at some point without realizing. The error >>>>> message >>>>> > > > was too ambiguous to catch this so i had to compare with a >>>>> previous >>>>> > > > working version of the arguments of MatSetValues, it was >>>>> evident then. >>>>> > > > >>>>> > > > Good news is that i can now set the values with the viennacl >>>>> types too, >>>>> > > > >>>>> > > > Thanks for your kind help, >>>>> > > > >>>>> > > > Manuel >>>>> > > > >>>>> > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >>>>> > > > > wrote: >>>>> > > > >>>>> > > > >>>>> > > > 1) PetscMalloc() is never valid or needed in Fortran >>>>> > > > >>>>> > > > 2) there is no reason to use >>>>> DMSetMatrixPreallocateOnly() >>>>> > > > just use DMCreateMatrix() assuming that using a DM (DMDA, >>>>> > > > DMPLEX, etc) is suitable for your problem. >>>>> > > > >>>>> > > > At this end we are totally guessing at what you are >>>>> doing >>>>> > > > and so have little help we can provide. A simple, >>>>> nonworking >>>>> > > > code that tries to do what you would need would help us >>>>> a great >>>>> > > > deal in understanding that you are trying to do. >>>>> > > > >>>>> > > > Barry >>>>> > > > >>>>> > > > >>>>> > > > >>>>> > > > >>>>> > > > >>>>> > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera >>>>> > > > > wrote: >>>>> > > > > >>>>> > > > > Matthew, PetscMalloc gives the same error, >>>>> > > > > >>>>> > > > > Barry, it would be very hard for me to get the code >>>>> to a >>>>> > > > minimum working example, i guess all i need to >>>>> understand is how >>>>> > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() >>>>> instead >>>>> > > > of MatMPIAIJSetPreallocation() as we were doing before, >>>>> is there >>>>> > > > a simple example who does this in Fortran? >>>>> > > > > >>>>> > > > > Is the PetscMalloc call needed? is 'call >>>>> > > > PetscMalloc(1,row,ierr)' a valid, compilable call to >>>>> > > > PetscMalloc? what other reason may there be for this >>>>> error to >>>>> > > > happen ? >>>>> > > > > >>>>> > > > > Just remembering, that trying to setup the matrix >>>>> with the >>>>> > > > MatAIJSetPreallocation() brings up an error to >>>>> acknowledge the >>>>> > > > viennacl datatypes and that's why i'm trying to make >>>>> this change >>>>> > > > on your recommendation, >>>>> > > > > >>>>> > > > > Thanks for your help, >>>>> > > > > >>>>> > > > > >>>>> > > > > >>>>> > > > > >>>>> > > > > >>>>> > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >>>>> > > > > wrote: >>>>> > > > > >>>>> > > > > Send your code in a way we can compile and run it; >>>>> it must >>>>> > > > be some simple issue that is hard to communicate in >>>>> email. >>>>> > > > > >>>>> > > > > Barry >>>>> > > > > >>>>> > > > > >>>>> > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >>>>> > > > > wrote: >>>>> > > > > > >>>>> > > > > > Hello everyone, >>>>> > > > > > >>>>> > > > > > I just had time to work on this again, and checked >>>>> the code >>>>> > > > for errors on the matrix entries, this is the exact code >>>>> i was >>>>> > > > using for creating the matrix without >>>>> > > > DMSetMatrixPreallocateOnly, using >>>>> MatMPIAIJSetPreallocation and >>>>> > > > it worked that way, but trying this way i get the same >>>>> 'Column >>>>> > > > too large' error using any number at the column position >>>>> of >>>>> > > > MatSetValues, >>>>> > > > > > >>>>> > > > > > I have set up my code to print the column argument >>>>> (n) of >>>>> > > > MatSetValues and in this case is 7 (lower than 124), it >>>>> still >>>>> > > > gives error, even entering a specific number in the >>>>> MatSetValues >>>>> > > > column argument position gives the same error. >>>>> > > > > > >>>>> > > > > > So next i went back to ex.50 here: >>>>> > > > >>>>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html >>>>> > > > < >>>>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html >>>>> > >>>>> > > > and it has a very similar structure except the >>>>> PetscMalloc1() >>>>> > > > call, so i tried adding that and got: >>>>> > > > > > >>>>> > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: >>>>> undefined >>>>> > > > reference to `petscmalloc1_' >>>>> > > > > > >>>>> > > > > > Any ideas on this behaviour? >>>>> > > > > > >>>>> > > > > > Thanks so much, >>>>> > > > > > >>>>> > > > > > >>>>> > > > > > >>>>> > > > > > >>>>> > > > > > >>>>> > > > > > >>>>> > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >>>>> > > > > wrote: >>>>> > > > > > >>>>> > > > > > Column too large: col 10980 max 124 >>>>> > > > > > >>>>> > > > > > You need to check the code that is generating >>>>> the matrix >>>>> > > > entries. The matrix has 124 columns but you are >>>>> attempting to >>>>> > > > put a value at column 10980 >>>>> > > > > > >>>>> > > > > > Barry >>>>> > > > > > >>>>> > > > > > >>>>> > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >>>>> > > > > wrote: >>>>> > > > > > > >>>>> > > > > > > Thanks Matthew and Barry, >>>>> > > > > > > >>>>> > > > > > > Now my code looks like: >>>>> > > > > > > >>>>> > > > > > > call >>>>> DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>>>> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>> > > > > > > call MatSetFromOptions(A,ierr) >>>>> > > > > > > call MatSetUp(A,ierr) >>>>> > > > > > > [...] >>>>> > > > > > > call >>>>> > > > >>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>> > > > > > > [...] >>>>> > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, ierr) >>>>> > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >>>>> > > > > > > >>>>> > > > > > > And i get a different error, now is: >>>>> > > > > > > >>>>> > > > > > > [0]PETSC ERROR: --------------------- Error >>>>> Message >>>>> > > > >>>>> -------------------------------------------------------------- >>>>> > > > > > > [0]PETSC ERROR: Argument out of range >>>>> > > > > > > [0]PETSC ERROR: Column too large: col 10980 max >>>>> 124 >>>>> > > > > > > [0]PETSC ERROR: See >>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>> > > > >>>>> for >>>>> > > > trouble shooting. >>>>> > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>> > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>> named node50 >>>>> > > > by valera Wed Aug 15 19:40:00 2018 >>>>> > > > > > > [0]PETSC ERROR: Configure options >>>>> PETSC_ARCH=cuda-debug >>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>> --with-shared-libraries=1 >>>>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>> > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line 442 >>>>> in >>>>> > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c >>>>> > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > > Thanks again, >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. >>>>> > > > > wrote: >>>>> > > > > > > >>>>> > > > > > > Should be >>>>> > > > > > > >>>>> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>> > > > > > > >>>>> > > > > > > and remove the rest. You need to set the type >>>>> of Mat >>>>> > > > you want the DM to return BEFORE you create the matrix. >>>>> > > > > > > >>>>> > > > > > > Barry >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >>>>> > > > > wrote: >>>>> > > > > > > > >>>>> > > > > > > > Ok thanks for clarifying that, i wasn't sure if >>>>> there >>>>> > > > were different types, >>>>> > > > > > > > >>>>> > > > > > > > Here is a stripped down version of my code, it >>>>> seems >>>>> > > > like the preallocation is working now since the matrix >>>>> > > > population part is working without problem, but here it >>>>> is for >>>>> > > > illustration purposes: >>>>> > > > > > > > >>>>> > > > > > > > call >>>>> DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>>> > > > > > > > call >>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>> > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>> > > > > > > > call >>>>> > > > >>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>> > > > > > > > call MatSetUp(A,ierr) >>>>> > > > > > > > [...] >>>>> > > > > > > > call >>>>> > > > >>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>> > > > > > > > [...] >>>>> > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, >>>>> ierr) >>>>> > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >>>>> > > > > > > > >>>>> > > > > > > > Adding the first line there did the trick, >>>>> > > > > > > > >>>>> > > > > > > > Now the problem seems to be the program is not >>>>> > > > recognizing the matrix as ViennaCL type when i try with >>>>> more >>>>> > > > than one processor, i get now: >>>>> > > > > > > > >>>>> > > > > > > > [0]PETSC ERROR: --------------------- Error >>>>> Message >>>>> > > > >>>>> -------------------------------------------------------------- >>>>> > > > > > > > [0]PETSC ERROR: No support for this operation >>>>> for this >>>>> > > > object type >>>>> > > > > > > > [0]PETSC ERROR: Currently only handles ViennaCL >>>>> matrices >>>>> > > > > > > > [0]PETSC ERROR: See >>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>> > > > >>>>> for >>>>> > > > trouble shooting. >>>>> > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>> > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>> named >>>>> > > > node50 by valera Wed Aug 15 14:44:22 2018 >>>>> > > > > > > > [0]PETSC ERROR: Configure options >>>>> PETSC_ARCH=cuda-debug >>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>> --with-shared-libraries=1 >>>>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>> > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 >>>>> in >>>>> > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/ >>>>> saviennacl.cu >>>>> > > > >>>>> > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>> > > > /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>> > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>>> > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>> > > > > > > > >>>>> > > > > > > > When running with: >>>>> > > > > > > > >>>>> > > > > > > > mpirun -n 1 ./gcmLEP.GPU >>>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >>>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>> aijviennacl >>>>> > > > -pc_type saviennacl -log_view >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > Thanks, >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew Knepley >>>>> > > > > wrote: >>>>> > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >>>>> > > > > wrote: >>>>> > > > > > > > It seems to be resumed on: I do not know how to >>>>> > > > preallocate a DM Matrix correctly. >>>>> > > > > > > > >>>>> > > > > > > > There is only one matrix type, Mat. There are no >>>>> > > > separate DM matrices. A DM can create a matrix for you >>>>> > > > > > > > using DMCreateMatrix(), but that is a Mat and >>>>> it is >>>>> > > > preallocated correctly. I am not sure what you are doing. >>>>> > > > > > > > >>>>> > > > > > > > Thanks, >>>>> > > > > > > > >>>>> > > > > > > > Matt >>>>> > > > > > > > >>>>> > > > > > > > The interesting part is that it only breaks >>>>> when i need >>>>> > > > to populate a GPU matrix from MPI, so kudos on that, but >>>>> it >>>>> > > > seems i need to do better on my code to get this setup >>>>> working, >>>>> > > > > > > > >>>>> > > > > > > > Any help would be appreciated, >>>>> > > > > > > > >>>>> > > > > > > > Thanks, >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew Knepley >>>>> > > > > wrote: >>>>> > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >>>>> > > > > wrote: >>>>> > > > > > > > Thanks Matthew, >>>>> > > > > > > > >>>>> > > > > > > > I try to do that when calling: >>>>> > > > > > > > >>>>> > > > > > > > call >>>>> > > > >>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>> > > > > > > > >>>>> > > > > > > > But i am not aware on how to do this for the DM >>>>> if it >>>>> > > > needs something more specific/different, >>>>> > > > > > > > >>>>> > > > > > > > The error says that your preallocation is wrong >>>>> for the >>>>> > > > values you are putting in. The DM does not control >>>>> either, >>>>> > > > > > > > so I do not understand your email. >>>>> > > > > > > > >>>>> > > > > > > > Thanks, >>>>> > > > > > > > >>>>> > > > > > > > Matt >>>>> > > > > > > > >>>>> > > > > > > > Thanks, >>>>> > > > > > > > >>>>> > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew Knepley >>>>> > > > > wrote: >>>>> > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>>>> > > > > wrote: >>>>> > > > > > > > Hello PETSc devs, >>>>> > > > > > > > >>>>> > > > > > > > I am running into an error when trying to use >>>>> the >>>>> > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same >>>>> code runs >>>>> > > > for MATSEQAIJVIENNACL type in one processor. The error >>>>> happens >>>>> > > > when calling MatSetValues for this specific >>>>> configuration. It >>>>> > > > does not occur when using MPI DMMatrix types only. >>>>> > > > > > > > >>>>> > > > > > > > The DM properly preallocates the matrix. I am >>>>> assuming >>>>> > > > you do not here. >>>>> > > > > > > > >>>>> > > > > > > > Matt >>>>> > > > > > > > >>>>> > > > > > > > Any help will be appreciated, >>>>> > > > > > > > >>>>> > > > > > > > Thanks, >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > My program call: >>>>> > > > > > > > >>>>> > > > > > > > mpirun -n 2 ./gcmLEP.GPU >>>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >>>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>> aijviennacl >>>>> > > > -pc_type saviennacl -log_view >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > The error (repeats after each MatSetValues >>>>> call): >>>>> > > > > > > > >>>>> > > > > > > > [1]PETSC ERROR: --------------------- Error >>>>> Message >>>>> > > > >>>>> -------------------------------------------------------------- >>>>> > > > > > > > [1]PETSC ERROR: Argument out of range >>>>> > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at >>>>> global >>>>> > > > row/column (75, 50) into matrix >>>>> > > > > > > > [1]PETSC ERROR: See >>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>> > > > >>>>> for >>>>> > > > trouble shooting. >>>>> > > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: >>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>> > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>> named >>>>> > > > node50 by valera Wed Aug 15 13:10:44 2018 >>>>> > > > > > > > [1]PETSC ERROR: Configure options >>>>> PETSC_ARCH=cuda-debug >>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>> --with-shared-libraries=1 >>>>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>> > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line >>>>> 608 in >>>>> > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>>>> > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > My Code structure: >>>>> > > > > > > > >>>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>>> > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, >>>>> ierr) >>>>> > > > > > > > if (numprocs > 1) then ! set matrix type >>>>> parallel >>>>> > > > > > > > ! Get local size >>>>> > > > > > > > call >>>>> DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>>>> > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) >>>>> > > > > > > > call VecDestroy(Tmpnat,ierr) >>>>> > > > > > > > ! Set matrix >>>>> > > > > > > > #ifdef GPU >>>>> > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >>>>> > > > > > > > call >>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>> > > > > > > > call >>>>> DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>> > > > > > > > print*,'SETTING GPU TYPES' >>>>> > > > > > > > #else >>>>> > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>>> > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) >>>>> > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! >>>>> > > > > > > > #endif >>>>> > > > > > > > call >>>>> > > > >>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>> > > > > > > > else ! set matrix type >>>>> sequential >>>>> > > > > > > > #ifdef GPU >>>>> > > > > > > > call >>>>> DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>>>> > > > > > > > call >>>>> DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>>>> > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>>> > > > > > > > print*,'SETTING GPU TYPES' >>>>> > > > > > > > #else >>>>> > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>>> > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >>>>> > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) >>>>> > > > > > > > #endif >>>>> > > > > > > > call MatSetUp(A,ierr) >>>>> > > > > > > > call >>>>> > > > getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>>> > > > > > > > >>>>> > > > > > > > do k=zstart,zend-1 >>>>> > > > > > > > do j=ystart,yend-1 >>>>> > > > > > > > do i=xstart,xend-1 >>>>> > > > > > > > [..] >>>>> > > > > > > > call >>>>> > > > >>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>> > > > > > > > [..] >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > -- >>>>> > > > > > > > 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 >>>>> > > > > > > > >>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>> > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > -- >>>>> > > > > > > > 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 >>>>> > > > > > > > >>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>> > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > >>>>> > > > > > > > -- >>>>> > > > > > > > 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 >>>>> > > > > > > > >>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>> > > > >>>>> > > > > > > > >>>>> > > > > > > >>>>> > > > > > > >>>>> > > > > > >>>>> > > > > > >>>>> > > > > >>>>> > > > > >>>>> > > > >>>>> > > > >>>>> > > > >>>>> > > > >>>>> > > > >>>>> > >>>>> > >>>>> > >>>>> >>>>> >>>> >>> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> >> > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Thu Aug 30 06:20:55 2018 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 30 Aug 2018 07:20:55 -0400 Subject: [petsc-users] Questions about x-window and matlab engine in PETSc In-Reply-To: References: Message-ID: On Thu, Aug 30, 2018 at 4:09 AM Yingjie Wu wrote: > Dear PETSc developer, > Hi, > Thank you very much for helping me solve the problem before. Recently, I > reinstalled my system and reinstalled PETSc and found the following > problems: > > 1. when I ran the example src/vec/vec/example/tutorial/ex3, there was a > error: > [0] PETSC ERROR: PETSc installed without X windows, Microsoft Graphics, > OpenGL ES, or GLUT / OpenGL on this machine > I installed PETSc following the official website. I don't know how to > solve this error. > If you want that support, you have to install one of those toolkits on your machine and then reconfigure PETSc. > 2. I want to use matlab to do input and output data. My data is mainly the > information of model parameters and initial values in each grid, which is > usually stored in the form of matrix or vector. In src / vec / vec / > example / tutorial / ex5, the input and output data in the binary file. > dat, but I don't know how to open it for subsequent analysis. I want to > input or output data to PETSc in the form of matrix and vector in MATLAB. I > don't know how to use MATLAB as the input and output interface. It would be > better if there were examples. > The easiest way to get Matlab vectors and matrices into PETSc is to use the Matlab modules in PETSc: https://bitbucket.org/petsc/petsc/src/master/share/petsc/matlab/ which allow you to read and write PETSc binary format, like PetscBinaryWrite.m. Then you just use VecLoad() and MatLoad() with a binary viewer. > 3. Is there a web page that can query the usage of PETSc function? For > example, > Http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Viewer/PetscViewerBinaryOpen.html > > For beginners like me, a web page that queries how functions are used is > very useful. > I am not sure what the question means. The manual page you are referencing is exactly what we recommend looking at. Thanks, Matt > Thanks, > Yingjie > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From huq2090 at gmail.com Thu Aug 30 09:36:31 2018 From: huq2090 at gmail.com (Fazlul Huq) Date: Thu, 30 Aug 2018 09:36:31 -0500 Subject: [petsc-users] Integration of hyper & trilinos Message-ID: Hello Petsc developers, 1. I want to integrate petsc with hyper and trilinos cause I want to solve some problems using multigrid. I know, I need to download and install both of them and then configure petsc with hyper and trilinos to use them with petsc. But, I don't know how to configure petsc with hyper and trilinos or any other package. Is it like, running some command from terminal or editing .bashrc file? Currently, this is the .bashrc file regarding petsc in my desktop: export PETSC_DIR=/home/jimmy/projects/petsc 2. Can I use c programming routine in petsc code and make and run it? If yes then what is the procedure? Last day I tried to do that but I got error message while making the file. Thanks. -- Fazlul Huq Graduate Research Assistant Department of Nuclear, Plasma & Radiological Engineering (NPRE) University of Illinois at Urbana-Champaign (UIUC) E-mail: huq2090 at gmail.com -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Thu Aug 30 09:40:45 2018 From: jed at jedbrown.org (Jed Brown) Date: Thu, 30 Aug 2018 08:40:45 -0600 Subject: [petsc-users] Integration of hyper & trilinos In-Reply-To: References: Message-ID: <87va7ror2q.fsf@jedbrown.org> You would configure PETSc with --download-hypre and --download-ml (this part of Trilinos can be installed on its own). Then run your application with run-time options like -pc_type hypre or -pc_type ml. See the user's manual and/or tutorials. Fazlul Huq writes: > Hello Petsc developers, > > 1. I want to integrate petsc with hyper and trilinos cause I want to solve > some problems using multigrid. I know, I need to download and install > both of them and then configure petsc with hyper and trilinos to use them > with petsc. But, I don't know how to configure petsc with hyper and > trilinos or any other package. Is it like, running some command from > terminal or editing .bashrc file? Currently, this is the .bashrc file > regarding petsc in my desktop: > > export PETSC_DIR=/home/jimmy/projects/petsc > > 2. Can I use c programming routine in petsc code and make and run it? If > yes then what is the procedure? Last day I tried to do that but I got error > message while making the file. > > Thanks. > > -- > > Fazlul Huq > Graduate Research Assistant > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > University of Illinois at Urbana-Champaign (UIUC) > E-mail: huq2090 at gmail.com From mvalera-w at sdsu.edu Thu Aug 30 09:51:57 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Thu, 30 Aug 2018 07:51:57 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: I thought newer NVIDIA cards had integrated circuits, not using PCI anymore, still the same case? How would the GPU clusters work, then? Let's say i have a cluster of GPUs communicated by an MPI node, would PETSc work on this configuration at some point? This would be my next step if I could make the MPI matrices work with GPU, we have such a cluster on campus. Are you familiar with the Magma library? It was recommended recently to tackle this problem, I am most interested in your insight, Thanks, On Thu, Aug 30, 2018, 3:10 AM Matthew Knepley wrote: > On Wed, Aug 29, 2018 at 6:21 PM Manuel Valera wrote: > >> I understand that Matthew, thanks, >> >> I am trying to see if i get any speedup in this configuration, otherwise >> i will be waiting for the MPIAIJ support on PETSc, >> >> Is there any other gpu preconditioner that works on parallel matrices >> directly? >> > > Not that I know of . Such a hypothetical preconditioner would need to pass > information back and forth, across the PCI bus, and > then through MPI (even if you imagine direct GPU-GPU communication, it > still hits the PCI bus). This channel has small bandwidth, > but even more limiting is the high latency. Its unclear what kind of > algorithm would do well in this situation. > > Thanks, > > Matt > > >> Thanks again, >> >> >> >> On Wed, Aug 29, 2018 at 3:05 PM, Matthew Knepley >> wrote: >> >>> On Wed, Aug 29, 2018 at 5:49 PM Manuel Valera >>> wrote: >>> >>>> Update: >>>> >>>> I made it work like you suggested Barry, i had to comment the code line >>>> to set up the pc_type saviennacl, that way i am getting as ksp_view: >>>> >>>> KSP Object: 2 MPI processes >>>> type: cg >>>> maximum iterations=10000, initial guess is zero >>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>> left preconditioning >>>> using PRECONDITIONED norm type for convergence test >>>> PC Object: 2 MPI processes >>>> type: bjacobi >>>> number of blocks = 2 >>>> Local solve is same for all blocks, in the following KSP and PC >>>> objects: >>>> KSP Object: (sub_) 1 MPI processes >>>> type: preonly >>>> maximum iterations=10000, initial guess is zero >>>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. >>>> left preconditioning >>>> using NONE norm type for convergence test >>>> PC Object: (sub_) 1 MPI processes >>>> type: ilu >>>> out-of-place factorization >>>> 0 levels of fill >>>> tolerance for zero pivot 2.22045e-14 >>>> matrix ordering: natural >>>> factor fill ratio given 1., needed 1. >>>> Factored matrix follows: >>>> Mat Object: 1 MPI processes >>>> type: seqaij >>>> rows=75, cols=75 >>>> package used to perform factorization: petsc >>>> total: nonzeros=927, allocated nonzeros=927 >>>> total number of mallocs used during MatSetValues calls =0 >>>> not using I-node routines >>>> linear system matrix = precond matrix: >>>> Mat Object: 1 MPI processes >>>> type: seqaijviennacl >>>> rows=75, cols=75 >>>> total: nonzeros=927, allocated nonzeros=1335 >>>> total number of mallocs used during MatSetValues calls =84 >>>> not using I-node routines >>>> linear system matrix = precond matrix: >>>> Mat Object: 2 MPI processes >>>> type: mpiaijviennacl >>>> rows=125, cols=125 >>>> total: nonzeros=1685, allocated nonzeros=2885 >>>> total number of mallocs used during MatSetValues calls =184 >>>> has attached near null space >>>> Press_Max: 1.9995807630564922E-004 >>>> >>>> >>>> This is what we want, right? >>>> >>>> Still if i try using pc_type saviennacl directly it breaks, >>>> >>> >>> You are missing the point of the error message. >>> >>> We do not support SAVIENNACL on parallel matrices (MPIAIJ). We do >>> support it >>> on serial matrices (SEQAIJ). When you are setting in directly, you are >>> applying it >>> to a parallel matrix. If you use Block-Jacobi, you are applying it to >>> each submatrix, >>> and those submatrices are all serial. >>> >>> Thanks, >>> >>> Matt >>> >>> >>>> Thanks for your help i'll try my speedup like this, >>>> >>>> >>>> >>>> >>>> >>>> On Wed, Aug 29, 2018 at 2:21 PM, Manuel Valera >>>> wrote: >>>> >>>>> Ok, executing with: >>>>> >>>>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>>>> jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view >>>>> >>>>> >>>>> I get: >>>>> >>>>> >>>>> SETTING GPU TYPES >>>>> Matrix type: mpiaijviennacl >>>>> >>>>> Of sizes: 125 x 125 >>>>> Matrix type: mpiaijviennacl >>>>> >>>>> Of sizes: 125 x 125 >>>>> [0]PETSC ERROR: --------------------- Error Message >>>>> -------------------------------------------------------------- >>>>> [0]PETSC ERROR: No support for this operation for this object type >>>>> [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>> [0]PETSC ERROR: See >>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>> shooting. >>>>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 >>>>> GIT Date: 2018-08-29 12:42:36 -0600 >>>>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>> Wed Aug 29 14:20:42 2018 >>>>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>> [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>> [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>> [1]PETSC ERROR: >>>>> ------------------------------------------------------------------------ >>>>> [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, >>>>> probably memory access out of range >>>>> [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] PetscTraceBackErrorHandler line 182 >>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>> [1]PETSC ERROR: [1] PetscError line 352 >>>>> /home/valera/petsc/src/sys/error/err.c >>>>> [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>> [1]PETSC ERROR: [1] PCSetUp line 894 >>>>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.3-1264-g6fb0cd4 >>>>> GIT Date: 2018-08-29 12:42:36 -0600 >>>>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>> Wed Aug 29 14:20:42 2018 >>>>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>> [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >>>>> >>>>> -------------------------------------------------------------------------- >>>>> MPI_ABORT was invoked on rank 1 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. >>>>> >>>>> -------------------------------------------------------------------------- >>>>> [0]PETSC ERROR: >>>>> ------------------------------------------------------------------------ >>>>> [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or >>>>> the batch system) has told this process to end >>>>> [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. >>>>> [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>>> /home/valera/petsc/src/sys/objects/tagm.c >>>>> [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 >>>>> /home/valera/petsc/src/sys/objects/inherit.c >>>>> [0]PETSC ERROR: [0] ISCreate line 35 >>>>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>>>> [0]PETSC ERROR: [0] ISCreateGeneral line 658 >>>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>>> [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>> [0]PETSC ERROR: [0] PCSetUp line 894 >>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>> [0]PETSC ERROR: --------------------- Error Message >>>>> -------------------------------------------------------------- >>>>> [0]PETSC ERROR: Signal received >>>>> [0]PETSC ERROR: See >>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>> shooting. >>>>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 >>>>> GIT Date: 2018-08-29 12:42:36 -0600 >>>>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>> Wed Aug 29 14:20:42 2018 >>>>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>> [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >>>>> [node50:77836] 1 more process has sent help message help-mpi-api.txt / >>>>> mpi-abort >>>>> [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to >>>>> see all help / error messages >>>>> >>>>> >>>>> >>>>> On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. >>>>> wrote: >>>>> >>>>>> Please send complete error message >>>>>> >>>>>> >>>>>> > On Aug 29, 2018, at 3:40 PM, Manuel Valera >>>>>> wrote: >>>>>> > >>>>>> > Yeah, no sorry, i get the same error with -pc_type bjacobi >>>>>> -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" >>>>>> > >>>>>> > >>>>>> > Thanks and let me know of any progress on this issue, >>>>>> > >>>>>> > >>>>>> > >>>>>> > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera >>>>>> wrote: >>>>>> > Awesome, thanks! >>>>>> > >>>>>> > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. < >>>>>> bsmith at mcs.anl.gov> wrote: >>>>>> > >>>>>> > >>>>>> > > On Aug 29, 2018, at 3:26 PM, Manuel Valera >>>>>> wrote: >>>>>> > > >>>>>> > > >>>>>> > > >>>>>> > > You may need to use just plain PCBJACOBI or PCASM for >>>>>> parallelism and then SAVIENNACL sequentially on each block. >>>>>> > > >>>>>> > > >>>>>> > > Can you elaborate a little in how to do this? do you mean i can >>>>>> only use viennacl in serial at the moment or this is a suggestion of a >>>>>> workaround on how to make it work? >>>>>> > >>>>>> > -pc_type bjacobi -sub_pc_type SAVIENNACL >>>>>> > >>>>>> > This will run in parallel and utilize the GPU for each block of >>>>>> the preconditioner. >>>>>> > >>>>>> > Barry >>>>>> > >>>>>> > > >>>>>> > > >>>>>> > > Thanks, >>>>>> > > >>>>>> > > >>>>>> > > >>>>>> > > >>>>>> > > >>>>>> > > >>>>>> > > >>>>>> > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera >>>>>> wrote: >>>>>> > > > >>>>>> > > > Hi everyone, >>>>>> > > > >>>>>> > > > Thanks for your responses, i understand communicating on this >>>>>> way to this level of technicality can be hard, i still think we can work >>>>>> ways to solve this problem though, >>>>>> > > > >>>>>> > > > I can say the following at this point: >>>>>> > > > >>>>>> > > > ? Program works without issues in any other non-gpu >>>>>> preconditioner, just by calling -pc_type ### . >>>>>> > > > ? Program works correctly with ViennaCL preconditioners >>>>>> with mpirun -n 1, that is on one processor. >>>>>> > > > ? Program breaks with every ViennaCL preconditioner when >>>>>> attempting any more than 1 processors. >>>>>> > > > ? I haven't tried other GPU preconditioners because >>>>>> ViennaCL gave the best performance in 1 processor before. >>>>>> > > > ? I have made sure the matrix type is mpiaijviennacl as >>>>>> it is printed right before the error log. >>>>>> > > > ? I am attaching what i think are the backtrace logs of >>>>>> the run with two cores, as i have limited experience with this kind of >>>>>> debugging, and i cannot make sense of what they say, please let me know if >>>>>> you need me to do something else. >>>>>> > > > >>>>>> > > > Current options i can think of are giving you permission to >>>>>> clone my model repo, or for you to guide me trough the process remotely, >>>>>> > > > >>>>>> > > > Thanks, >>>>>> > > > >>>>>> > > > .-.-.-.- >>>>>> > > > >>>>>> > > > >>>>>> > > > The error i get is still: >>>>>> > > > >>>>>> > > > Matrix type: mpiaijviennacl >>>>>> >>>>>> > > > Of sizes: 125 x 125 >>>>>> > > > Matrix type: mpiaijviennacl >>>>>> >>>>>> > > > Of sizes: 125 x 125 >>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>> -------------------------------------------------------------- >>>>>> > > > [0]PETSC ERROR: No support for this operation for this object >>>>>> type >>>>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>> > > > [0]PETSC ERROR: See >>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>> shooting. >>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>> > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>> > > > [1]PETSC ERROR: >>>>>> ------------------------------------------------------------------------ >>>>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>>> Violation, probably memory access out of range >>>>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>>>> /home/valera/petsc/src/sys/error/err.c >>>>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>> > > > [1]PETSC ERROR: [1] KSPSetUp line 294 >>>>>> /home/valera/petsc/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 Development GIT revision: >>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown >>>>>> file >>>>>> > > > >>>>>> -------------------------------------------------------------------------- >>>>>> > > > MPI_ABORT was invoked on rank 1 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. >>>>>> > > > >>>>>> -------------------------------------------------------------------------- >>>>>> > > > [0]PETSC ERROR: >>>>>> ------------------------------------------------------------------------ >>>>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process >>>>>> (or the batch system) has told this process to end >>>>>> > > > [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. >>>>>> > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 >>>>>> /home/valera/petsc/src/mat/utils/gcreate.c >>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>> > > > [0]PETSC ERROR: [0] KSPSetUp line 294 >>>>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>> -------------------------------------------------------------- >>>>>> > > > [0]PETSC ERROR: Signal received >>>>>> > > > [0]PETSC ERROR: See >>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>> shooting. >>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>> > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown >>>>>> file >>>>>> > > > [node50:32783] 1 more process has sent help message >>>>>> help-mpi-api.txt / mpi-abort >>>>>> > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to >>>>>> 0 to see all help / error messages >>>>>> > > > >>>>>> > > > >>>>>> > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp < >>>>>> rupp at iue.tuwien.ac.at> wrote: >>>>>> > > > Hi Manuel, >>>>>> > > > >>>>>> > > > as Barry said, it is hard for us to provide any help without >>>>>> having a more complete picture of what is going on. >>>>>> > > > >>>>>> > > > The error you report seems to come from the AMG preconditioner >>>>>> in ViennaCL. This can have many origins. Do other preconditioners run >>>>>> without error? Can you run in a debugger and provide a complete backtrace? >>>>>> > > > >>>>>> > > > Thanks and best regards, >>>>>> > > > Karli >>>>>> > > > >>>>>> > > > >>>>>> > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: >>>>>> > > > Talked too fast, >>>>>> > > > >>>>>> > > > After fixing that problem, i tried more than one mpi processor >>>>>> and got the following: >>>>>> > > > >>>>>> > > > Matrix type: mpiaijviennacl >>>>>> > > > Of sizes: 125 x 125 >>>>>> > > > Matrix type: mpiaijviennacl >>>>>> > > > Of sizes: 125 x 125 >>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>> -------------------------------------------------------------- >>>>>> > > > [0]PETSC ERROR: No support for this operation for this object >>>>>> type >>>>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>> > > > [0]PETSC ERROR: See >>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>> shooting. >>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >>>>>> http://saviennacl.cu> >>>>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>> > > > [1]PETSC ERROR: >>>>>> ------------------------------------------------------------------------ >>>>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>>> Violation, probably memory access out of range >>>>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>>>> /home/valera/petsc/src/sys/error/err.c >>>>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>>>> http://saviennacl.cu> >>>>>> > > > >>>>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: >>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown >>>>>> file >>>>>> > > > >>>>>> -------------------------------------------------------------------------- >>>>>> > > > MPI_ABORT was invoked on rank 1 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. >>>>>> > > > >>>>>> -------------------------------------------------------------------------- >>>>>> > > > [0]PETSC ERROR: >>>>>> ------------------------------------------------------------------------ >>>>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some process >>>>>> (or the batch system) has told this process to end >>>>>> > > > [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. >>>>>> > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>>>> /home/valera/petsc/src/sys/objects/tagm.c >>>>>> > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >>>>>> /home/valera/petsc/src/sys/objects/inherit.c >>>>>> > > > [0]PETSC ERROR: [0] ISCreate line 35 >>>>>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>>>>> > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 >>>>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>>>> http://saviennacl.cu> >>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>> -------------------------------------------------------------- >>>>>> > > > [0]PETSC ERROR: Signal received >>>>>> > > > [0]PETSC ERROR: See >>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>> shooting. >>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>> > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown >>>>>> file >>>>>> > > > [node50:30582] 1 more process has sent help message >>>>>> help-mpi-api.txt / mpi-abort >>>>>> > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to >>>>>> 0 to see all help / error messages >>>>>> > > > >>>>>> > > > >>>>>> > > > >>>>>> > > > It is currently running in 1 mpi processor + GPU but i would >>>>>> like to call at least 16 mpi processors + GPU to do the rest of the data >>>>>> management who is not part of the main laplacian on the mpi and the >>>>>> laplacian solution on the GPU, is this currently possible? >>>>>> > > > >>>>>> > > > Thanks for your help, >>>>>> > > > >>>>>> > > > >>>>>> > > > >>>>>> > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera < >>>>>> mvalera-w at sdsu.edu > wrote: >>>>>> > > > >>>>>> > > > Ok, i found the culprit and we can close this thread, >>>>>> > > > >>>>>> > > > The problem was a missing variable for setting the maximum >>>>>> columns, >>>>>> > > > which i deleted at some point without realizing. The error >>>>>> message >>>>>> > > > was too ambiguous to catch this so i had to compare with a >>>>>> previous >>>>>> > > > working version of the arguments of MatSetValues, it was >>>>>> evident then. >>>>>> > > > >>>>>> > > > Good news is that i can now set the values with the >>>>>> viennacl types too, >>>>>> > > > >>>>>> > > > Thanks for your kind help, >>>>>> > > > >>>>>> > > > Manuel >>>>>> > > > >>>>>> > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >>>>>> > > > > wrote: >>>>>> > > > >>>>>> > > > >>>>>> > > > 1) PetscMalloc() is never valid or needed in Fortran >>>>>> > > > >>>>>> > > > 2) there is no reason to use >>>>>> DMSetMatrixPreallocateOnly() >>>>>> > > > just use DMCreateMatrix() assuming that using a DM >>>>>> (DMDA, >>>>>> > > > DMPLEX, etc) is suitable for your problem. >>>>>> > > > >>>>>> > > > At this end we are totally guessing at what you >>>>>> are doing >>>>>> > > > and so have little help we can provide. A simple, >>>>>> nonworking >>>>>> > > > code that tries to do what you would need would help us >>>>>> a great >>>>>> > > > deal in understanding that you are trying to do. >>>>>> > > > >>>>>> > > > Barry >>>>>> > > > >>>>>> > > > >>>>>> > > > >>>>>> > > > >>>>>> > > > >>>>>> > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera >>>>>> > > > > wrote: >>>>>> > > > > >>>>>> > > > > Matthew, PetscMalloc gives the same error, >>>>>> > > > > >>>>>> > > > > Barry, it would be very hard for me to get the code >>>>>> to a >>>>>> > > > minimum working example, i guess all i need to >>>>>> understand is how >>>>>> > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() >>>>>> instead >>>>>> > > > of MatMPIAIJSetPreallocation() as we were doing before, >>>>>> is there >>>>>> > > > a simple example who does this in Fortran? >>>>>> > > > > >>>>>> > > > > Is the PetscMalloc call needed? is 'call >>>>>> > > > PetscMalloc(1,row,ierr)' a valid, compilable call to >>>>>> > > > PetscMalloc? what other reason may there be for this >>>>>> error to >>>>>> > > > happen ? >>>>>> > > > > >>>>>> > > > > Just remembering, that trying to setup the matrix >>>>>> with the >>>>>> > > > MatAIJSetPreallocation() brings up an error to >>>>>> acknowledge the >>>>>> > > > viennacl datatypes and that's why i'm trying to make >>>>>> this change >>>>>> > > > on your recommendation, >>>>>> > > > > >>>>>> > > > > Thanks for your help, >>>>>> > > > > >>>>>> > > > > >>>>>> > > > > >>>>>> > > > > >>>>>> > > > > >>>>>> > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >>>>>> > > > > wrote: >>>>>> > > > > >>>>>> > > > > Send your code in a way we can compile and run >>>>>> it; it must >>>>>> > > > be some simple issue that is hard to communicate in >>>>>> email. >>>>>> > > > > >>>>>> > > > > Barry >>>>>> > > > > >>>>>> > > > > >>>>>> > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >>>>>> > > > > wrote: >>>>>> > > > > > >>>>>> > > > > > Hello everyone, >>>>>> > > > > > >>>>>> > > > > > I just had time to work on this again, and checked >>>>>> the code >>>>>> > > > for errors on the matrix entries, this is the exact >>>>>> code i was >>>>>> > > > using for creating the matrix without >>>>>> > > > DMSetMatrixPreallocateOnly, using >>>>>> MatMPIAIJSetPreallocation and >>>>>> > > > it worked that way, but trying this way i get the same >>>>>> 'Column >>>>>> > > > too large' error using any number at the column >>>>>> position of >>>>>> > > > MatSetValues, >>>>>> > > > > > >>>>>> > > > > > I have set up my code to print the column argument >>>>>> (n) of >>>>>> > > > MatSetValues and in this case is 7 (lower than 124), it >>>>>> still >>>>>> > > > gives error, even entering a specific number in the >>>>>> MatSetValues >>>>>> > > > column argument position gives the same error. >>>>>> > > > > > >>>>>> > > > > > So next i went back to ex.50 here: >>>>>> > > > >>>>>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html >>>>>> > > > < >>>>>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html >>>>>> > >>>>>> > > > and it has a very similar structure except the >>>>>> PetscMalloc1() >>>>>> > > > call, so i tried adding that and got: >>>>>> > > > > > >>>>>> > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: >>>>>> undefined >>>>>> > > > reference to `petscmalloc1_' >>>>>> > > > > > >>>>>> > > > > > Any ideas on this behaviour? >>>>>> > > > > > >>>>>> > > > > > Thanks so much, >>>>>> > > > > > >>>>>> > > > > > >>>>>> > > > > > >>>>>> > > > > > >>>>>> > > > > > >>>>>> > > > > > >>>>>> > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >>>>>> > > > > wrote: >>>>>> > > > > > >>>>>> > > > > > Column too large: col 10980 max 124 >>>>>> > > > > > >>>>>> > > > > > You need to check the code that is generating >>>>>> the matrix >>>>>> > > > entries. The matrix has 124 columns but you are >>>>>> attempting to >>>>>> > > > put a value at column 10980 >>>>>> > > > > > >>>>>> > > > > > Barry >>>>>> > > > > > >>>>>> > > > > > >>>>>> > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >>>>>> > > > > wrote: >>>>>> > > > > > > >>>>>> > > > > > > Thanks Matthew and Barry, >>>>>> > > > > > > >>>>>> > > > > > > Now my code looks like: >>>>>> > > > > > > >>>>>> > > > > > > call >>>>>> DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>>>>> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>> > > > > > > call MatSetFromOptions(A,ierr) >>>>>> > > > > > > call MatSetUp(A,ierr) >>>>>> > > > > > > [...] >>>>>> > > > > > > call >>>>>> > > > >>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>> > > > > > > [...] >>>>>> > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, >>>>>> ierr) >>>>>> > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >>>>>> > > > > > > >>>>>> > > > > > > And i get a different error, now is: >>>>>> > > > > > > >>>>>> > > > > > > [0]PETSC ERROR: --------------------- Error >>>>>> Message >>>>>> > > > >>>>>> -------------------------------------------------------------- >>>>>> > > > > > > [0]PETSC ERROR: Argument out of range >>>>>> > > > > > > [0]PETSC ERROR: Column too large: col 10980 max >>>>>> 124 >>>>>> > > > > > > [0]PETSC ERROR: See >>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>> > > > >>>>>> for >>>>>> > > > trouble shooting. >>>>>> > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>> > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>>> named node50 >>>>>> > > > by valera Wed Aug 15 19:40:00 2018 >>>>>> > > > > > > [0]PETSC ERROR: Configure options >>>>>> PETSC_ARCH=cuda-debug >>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>> --with-shared-libraries=1 >>>>>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>> > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line >>>>>> 442 in >>>>>> > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c >>>>>> > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > Thanks again, >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. >>>>>> > > > > wrote: >>>>>> > > > > > > >>>>>> > > > > > > Should be >>>>>> > > > > > > >>>>>> > > > > > > call DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>> > > > > > > >>>>>> > > > > > > and remove the rest. You need to set the type >>>>>> of Mat >>>>>> > > > you want the DM to return BEFORE you create the matrix. >>>>>> > > > > > > >>>>>> > > > > > > Barry >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >>>>>> > > > > wrote: >>>>>> > > > > > > > >>>>>> > > > > > > > Ok thanks for clarifying that, i wasn't sure >>>>>> if there >>>>>> > > > were different types, >>>>>> > > > > > > > >>>>>> > > > > > > > Here is a stripped down version of my code, it >>>>>> seems >>>>>> > > > like the preallocation is working now since the matrix >>>>>> > > > population part is working without problem, but here it >>>>>> is for >>>>>> > > > illustration purposes: >>>>>> > > > > > > > >>>>>> > > > > > > > call >>>>>> DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>>>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>>>> > > > > > > > call >>>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>> > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>> > > > > > > > call >>>>>> > > > >>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>> > > > > > > > call MatSetUp(A,ierr) >>>>>> > > > > > > > [...] >>>>>> > > > > > > > call >>>>>> > > > >>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>> > > > > > > > [...] >>>>>> > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, >>>>>> ierr) >>>>>> > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, >>>>>> ierr) >>>>>> > > > > > > > >>>>>> > > > > > > > Adding the first line there did the trick, >>>>>> > > > > > > > >>>>>> > > > > > > > Now the problem seems to be the program is not >>>>>> > > > recognizing the matrix as ViennaCL type when i try with >>>>>> more >>>>>> > > > than one processor, i get now: >>>>>> > > > > > > > >>>>>> > > > > > > > [0]PETSC ERROR: --------------------- Error >>>>>> Message >>>>>> > > > >>>>>> -------------------------------------------------------------- >>>>>> > > > > > > > [0]PETSC ERROR: No support for this operation >>>>>> for this >>>>>> > > > object type >>>>>> > > > > > > > [0]PETSC ERROR: Currently only handles >>>>>> ViennaCL matrices >>>>>> > > > > > > > [0]PETSC ERROR: See >>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>> > > > >>>>>> for >>>>>> > > > trouble shooting. >>>>>> > > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>> > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>>> named >>>>>> > > > node50 by valera Wed Aug 15 14:44:22 2018 >>>>>> > > > > > > > [0]PETSC ERROR: Configure options >>>>>> PETSC_ARCH=cuda-debug >>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>> --with-shared-libraries=1 >>>>>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>> > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line >>>>>> 47 in >>>>>> > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/ >>>>>> saviennacl.cu >>>>>> > > > >>>>>> > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>> > > > /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>> > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>>>> > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>> > > > > > > > >>>>>> > > > > > > > When running with: >>>>>> > > > > > > > >>>>>> > > > > > > > mpirun -n 1 ./gcmLEP.GPU >>>>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >>>>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>>> aijviennacl >>>>>> > > > -pc_type saviennacl -log_view >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > Thanks, >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew >>>>>> Knepley >>>>>> > > > > wrote: >>>>>> > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >>>>>> > > > > wrote: >>>>>> > > > > > > > It seems to be resumed on: I do not know how to >>>>>> > > > preallocate a DM Matrix correctly. >>>>>> > > > > > > > >>>>>> > > > > > > > There is only one matrix type, Mat. There are >>>>>> no >>>>>> > > > separate DM matrices. A DM can create a matrix for you >>>>>> > > > > > > > using DMCreateMatrix(), but that is a Mat and >>>>>> it is >>>>>> > > > preallocated correctly. I am not sure what you are >>>>>> doing. >>>>>> > > > > > > > >>>>>> > > > > > > > Thanks, >>>>>> > > > > > > > >>>>>> > > > > > > > Matt >>>>>> > > > > > > > >>>>>> > > > > > > > The interesting part is that it only breaks >>>>>> when i need >>>>>> > > > to populate a GPU matrix from MPI, so kudos on that, >>>>>> but it >>>>>> > > > seems i need to do better on my code to get this setup >>>>>> working, >>>>>> > > > > > > > >>>>>> > > > > > > > Any help would be appreciated, >>>>>> > > > > > > > >>>>>> > > > > > > > Thanks, >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew >>>>>> Knepley >>>>>> > > > > wrote: >>>>>> > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >>>>>> > > > > wrote: >>>>>> > > > > > > > Thanks Matthew, >>>>>> > > > > > > > >>>>>> > > > > > > > I try to do that when calling: >>>>>> > > > > > > > >>>>>> > > > > > > > call >>>>>> > > > >>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>> > > > > > > > >>>>>> > > > > > > > But i am not aware on how to do this for the >>>>>> DM if it >>>>>> > > > needs something more specific/different, >>>>>> > > > > > > > >>>>>> > > > > > > > The error says that your preallocation is >>>>>> wrong for the >>>>>> > > > values you are putting in. The DM does not control >>>>>> either, >>>>>> > > > > > > > so I do not understand your email. >>>>>> > > > > > > > >>>>>> > > > > > > > Thanks, >>>>>> > > > > > > > >>>>>> > > > > > > > Matt >>>>>> > > > > > > > >>>>>> > > > > > > > Thanks, >>>>>> > > > > > > > >>>>>> > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew >>>>>> Knepley >>>>>> > > > > wrote: >>>>>> > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>>>>> > > > > wrote: >>>>>> > > > > > > > Hello PETSc devs, >>>>>> > > > > > > > >>>>>> > > > > > > > I am running into an error when trying to use >>>>>> the >>>>>> > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same >>>>>> code runs >>>>>> > > > for MATSEQAIJVIENNACL type in one processor. The error >>>>>> happens >>>>>> > > > when calling MatSetValues for this specific >>>>>> configuration. It >>>>>> > > > does not occur when using MPI DMMatrix types only. >>>>>> > > > > > > > >>>>>> > > > > > > > The DM properly preallocates the matrix. I am >>>>>> assuming >>>>>> > > > you do not here. >>>>>> > > > > > > > >>>>>> > > > > > > > Matt >>>>>> > > > > > > > >>>>>> > > > > > > > Any help will be appreciated, >>>>>> > > > > > > > >>>>>> > > > > > > > Thanks, >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > My program call: >>>>>> > > > > > > > >>>>>> > > > > > > > mpirun -n 2 ./gcmLEP.GPU >>>>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ jid=tiny_cuda_test_n2 >>>>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>>> aijviennacl >>>>>> > > > -pc_type saviennacl -log_view >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > The error (repeats after each MatSetValues >>>>>> call): >>>>>> > > > > > > > >>>>>> > > > > > > > [1]PETSC ERROR: --------------------- Error >>>>>> Message >>>>>> > > > >>>>>> -------------------------------------------------------------- >>>>>> > > > > > > > [1]PETSC ERROR: Argument out of range >>>>>> > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at >>>>>> global >>>>>> > > > row/column (75, 50) into matrix >>>>>> > > > > > > > [1]PETSC ERROR: See >>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>> > > > >>>>>> for >>>>>> > > > trouble shooting. >>>>>> > > > > > > > [1]PETSC ERROR: Petsc Development GIT revision: >>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>> > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>>> named >>>>>> > > > node50 by valera Wed Aug 15 13:10:44 2018 >>>>>> > > > > > > > [1]PETSC ERROR: Configure options >>>>>> PETSC_ARCH=cuda-debug >>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>> --with-shared-libraries=1 >>>>>> > > > --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>> > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line >>>>>> 608 in >>>>>> > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>>>>> > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > My Code structure: >>>>>> > > > > > > > >>>>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>>>> > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, numprocs, >>>>>> ierr) >>>>>> > > > > > > > if (numprocs > 1) then ! set matrix type >>>>>> parallel >>>>>> > > > > > > > ! Get local size >>>>>> > > > > > > > call >>>>>> DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>>>>> > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) >>>>>> > > > > > > > call VecDestroy(Tmpnat,ierr) >>>>>> > > > > > > > ! Set matrix >>>>>> > > > > > > > #ifdef GPU >>>>>> > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >>>>>> > > > > > > > call >>>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>> > > > > > > > call >>>>>> DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>> > > > > > > > print*,'SETTING GPU TYPES' >>>>>> > > > > > > > #else >>>>>> > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>>>> > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) >>>>>> > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! >>>>>> > > > > > > > #endif >>>>>> > > > > > > > call >>>>>> > > > >>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>> > > > > > > > else ! set matrix type >>>>>> sequential >>>>>> > > > > > > > #ifdef GPU >>>>>> > > > > > > > call >>>>>> DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>>>>> > > > > > > > call >>>>>> DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>>>>> > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>>>> > > > > > > > print*,'SETTING GPU TYPES' >>>>>> > > > > > > > #else >>>>>> > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>>>> > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >>>>>> > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) >>>>>> > > > > > > > #endif >>>>>> > > > > > > > call MatSetUp(A,ierr) >>>>>> > > > > > > > call >>>>>> > > > >>>>>> getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>>>> > > > > > > > >>>>>> > > > > > > > do k=zstart,zend-1 >>>>>> > > > > > > > do j=ystart,yend-1 >>>>>> > > > > > > > do i=xstart,xend-1 >>>>>> > > > > > > > [..] >>>>>> > > > > > > > call >>>>>> > > > >>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>> > > > > > > > [..] >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > -- >>>>>> > > > > > > > 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 >>>>>> > > > > > > > >>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>> > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > -- >>>>>> > > > > > > > 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 >>>>>> > > > > > > > >>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>> > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > >>>>>> > > > > > > > -- >>>>>> > > > > > > > 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 >>>>>> > > > > > > > >>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>> > > > >>>>>> > > > > > > > >>>>>> > > > > > > >>>>>> > > > > > > >>>>>> > > > > > >>>>>> > > > > > >>>>>> > > > > >>>>>> > > > > >>>>>> > > > >>>>>> > > > >>>>>> > > > >>>>>> > > > >>>>>> > > > >>>>>> > >>>>>> > >>>>>> > >>>>>> >>>>>> >>>>> >>>> >>> >>> -- >>> 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 >>> >>> https://www.cse.buffalo.edu/~knepley/ >>> >>> >> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Thu Aug 30 10:25:03 2018 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 30 Aug 2018 11:25:03 -0400 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: On Thu, Aug 30, 2018 at 10:52 AM Manuel Valera wrote: > I thought newer NVIDIA cards had integrated circuits, not using PCI > anymore, still the same case? > > How would the GPU clusters work, then? Let's say i have a cluster of GPUs > communicated by an MPI node, would PETSc work on this configuration at some > point? This would be my next step if I could make the MPI matrices work > with GPU, we have such a cluster on campus. > That works now, in that you just use more loosely coupled preconditioners, like ASM. That was my point. Its unlikely that tightly coupled PCs would be useful in this regime. > Are you familiar with the Magma library? It was recommended recently to > tackle this problem, > It does not tackle this problem. Thanks, Matt > I am most interested in your insight, > > Thanks, > > On Thu, Aug 30, 2018, 3:10 AM Matthew Knepley wrote: > >> On Wed, Aug 29, 2018 at 6:21 PM Manuel Valera wrote: >> >>> I understand that Matthew, thanks, >>> >>> I am trying to see if i get any speedup in this configuration, otherwise >>> i will be waiting for the MPIAIJ support on PETSc, >>> >>> Is there any other gpu preconditioner that works on parallel matrices >>> directly? >>> >> >> Not that I know of . Such a hypothetical preconditioner would need to >> pass information back and forth, across the PCI bus, and >> then through MPI (even if you imagine direct GPU-GPU communication, it >> still hits the PCI bus). This channel has small bandwidth, >> but even more limiting is the high latency. Its unclear what kind of >> algorithm would do well in this situation. >> >> Thanks, >> >> Matt >> >> >>> Thanks again, >>> >>> >>> >>> On Wed, Aug 29, 2018 at 3:05 PM, Matthew Knepley >>> wrote: >>> >>>> On Wed, Aug 29, 2018 at 5:49 PM Manuel Valera >>>> wrote: >>>> >>>>> Update: >>>>> >>>>> I made it work like you suggested Barry, i had to comment the code >>>>> line to set up the pc_type saviennacl, that way i am getting as ksp_view: >>>>> >>>>> KSP Object: 2 MPI processes >>>>> type: cg >>>>> maximum iterations=10000, initial guess is zero >>>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>>> left preconditioning >>>>> using PRECONDITIONED norm type for convergence test >>>>> PC Object: 2 MPI processes >>>>> type: bjacobi >>>>> number of blocks = 2 >>>>> Local solve is same for all blocks, in the following KSP and PC >>>>> objects: >>>>> KSP Object: (sub_) 1 MPI processes >>>>> type: preonly >>>>> maximum iterations=10000, initial guess is zero >>>>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. >>>>> left preconditioning >>>>> using NONE norm type for convergence test >>>>> PC Object: (sub_) 1 MPI processes >>>>> type: ilu >>>>> out-of-place factorization >>>>> 0 levels of fill >>>>> tolerance for zero pivot 2.22045e-14 >>>>> matrix ordering: natural >>>>> factor fill ratio given 1., needed 1. >>>>> Factored matrix follows: >>>>> Mat Object: 1 MPI processes >>>>> type: seqaij >>>>> rows=75, cols=75 >>>>> package used to perform factorization: petsc >>>>> total: nonzeros=927, allocated nonzeros=927 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> not using I-node routines >>>>> linear system matrix = precond matrix: >>>>> Mat Object: 1 MPI processes >>>>> type: seqaijviennacl >>>>> rows=75, cols=75 >>>>> total: nonzeros=927, allocated nonzeros=1335 >>>>> total number of mallocs used during MatSetValues calls =84 >>>>> not using I-node routines >>>>> linear system matrix = precond matrix: >>>>> Mat Object: 2 MPI processes >>>>> type: mpiaijviennacl >>>>> rows=125, cols=125 >>>>> total: nonzeros=1685, allocated nonzeros=2885 >>>>> total number of mallocs used during MatSetValues calls =184 >>>>> has attached near null space >>>>> Press_Max: 1.9995807630564922E-004 >>>>> >>>>> >>>>> This is what we want, right? >>>>> >>>>> Still if i try using pc_type saviennacl directly it breaks, >>>>> >>>> >>>> You are missing the point of the error message. >>>> >>>> We do not support SAVIENNACL on parallel matrices (MPIAIJ). We do >>>> support it >>>> on serial matrices (SEQAIJ). When you are setting in directly, you are >>>> applying it >>>> to a parallel matrix. If you use Block-Jacobi, you are applying it to >>>> each submatrix, >>>> and those submatrices are all serial. >>>> >>>> Thanks, >>>> >>>> Matt >>>> >>>> >>>>> Thanks for your help i'll try my speedup like this, >>>>> >>>>> >>>>> >>>>> >>>>> >>>>> On Wed, Aug 29, 2018 at 2:21 PM, Manuel Valera >>>>> wrote: >>>>> >>>>>> Ok, executing with: >>>>>> >>>>>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>>>>> jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view >>>>>> >>>>>> >>>>>> I get: >>>>>> >>>>>> >>>>>> SETTING GPU TYPES >>>>>> Matrix type: mpiaijviennacl >>>>>> >>>>>> Of sizes: 125 x 125 >>>>>> Matrix type: mpiaijviennacl >>>>>> >>>>>> Of sizes: 125 x 125 >>>>>> [0]PETSC ERROR: --------------------- Error Message >>>>>> -------------------------------------------------------------- >>>>>> [0]PETSC ERROR: No support for this operation for this object type >>>>>> [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>> [0]PETSC ERROR: See >>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>> shooting. >>>>>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 >>>>>> GIT Date: 2018-08-29 12:42:36 -0600 >>>>>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>> Wed Aug 29 14:20:42 2018 >>>>>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>>> [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>> [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>> [1]PETSC ERROR: >>>>>> ------------------------------------------------------------------------ >>>>>> [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation Violation, >>>>>> probably memory access out of range >>>>>> [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] PetscTraceBackErrorHandler line 182 >>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>> [1]PETSC ERROR: [1] PetscError line 352 >>>>>> /home/valera/petsc/src/sys/error/err.c >>>>>> [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>> [1]PETSC ERROR: [1] PCSetUp line 894 >>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: v3.9.3-1264-g6fb0cd4 >>>>>> GIT Date: 2018-08-29 12:42:36 -0600 >>>>>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>> Wed Aug 29 14:20:42 2018 >>>>>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>>> [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >>>>>> >>>>>> -------------------------------------------------------------------------- >>>>>> MPI_ABORT was invoked on rank 1 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. >>>>>> >>>>>> -------------------------------------------------------------------------- >>>>>> [0]PETSC ERROR: >>>>>> ------------------------------------------------------------------------ >>>>>> [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or >>>>>> the batch system) has told this process to end >>>>>> [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. >>>>>> [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>>>> /home/valera/petsc/src/sys/objects/tagm.c >>>>>> [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 >>>>>> /home/valera/petsc/src/sys/objects/inherit.c >>>>>> [0]PETSC ERROR: [0] ISCreate line 35 >>>>>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>>>>> [0]PETSC ERROR: [0] ISCreateGeneral line 658 >>>>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>>>> [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>> [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>> [0]PETSC ERROR: --------------------- Error Message >>>>>> -------------------------------------------------------------- >>>>>> [0]PETSC ERROR: Signal received >>>>>> [0]PETSC ERROR: See >>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>> shooting. >>>>>> [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1264-g6fb0cd4 >>>>>> GIT Date: 2018-08-29 12:42:36 -0600 >>>>>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>> Wed Aug 29 14:20:42 2018 >>>>>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>>> [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >>>>>> [node50:77836] 1 more process has sent help message help-mpi-api.txt >>>>>> / mpi-abort >>>>>> [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to >>>>>> see all help / error messages >>>>>> >>>>>> >>>>>> >>>>>> On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. >>>>>> wrote: >>>>>> >>>>>>> Please send complete error message >>>>>>> >>>>>>> >>>>>>> > On Aug 29, 2018, at 3:40 PM, Manuel Valera >>>>>>> wrote: >>>>>>> > >>>>>>> > Yeah, no sorry, i get the same error with -pc_type bjacobi >>>>>>> -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" >>>>>>> > >>>>>>> > >>>>>>> > Thanks and let me know of any progress on this issue, >>>>>>> > >>>>>>> > >>>>>>> > >>>>>>> > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera >>>>>>> wrote: >>>>>>> > Awesome, thanks! >>>>>>> > >>>>>>> > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. < >>>>>>> bsmith at mcs.anl.gov> wrote: >>>>>>> > >>>>>>> > >>>>>>> > > On Aug 29, 2018, at 3:26 PM, Manuel Valera >>>>>>> wrote: >>>>>>> > > >>>>>>> > > >>>>>>> > > >>>>>>> > > You may need to use just plain PCBJACOBI or PCASM for >>>>>>> parallelism and then SAVIENNACL sequentially on each block. >>>>>>> > > >>>>>>> > > >>>>>>> > > Can you elaborate a little in how to do this? do you mean i can >>>>>>> only use viennacl in serial at the moment or this is a suggestion of a >>>>>>> workaround on how to make it work? >>>>>>> > >>>>>>> > -pc_type bjacobi -sub_pc_type SAVIENNACL >>>>>>> > >>>>>>> > This will run in parallel and utilize the GPU for each block >>>>>>> of the preconditioner. >>>>>>> > >>>>>>> > Barry >>>>>>> > >>>>>>> > > >>>>>>> > > >>>>>>> > > Thanks, >>>>>>> > > >>>>>>> > > >>>>>>> > > >>>>>>> > > >>>>>>> > > >>>>>>> > > >>>>>>> > > >>>>>>> > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera >>>>>>> wrote: >>>>>>> > > > >>>>>>> > > > Hi everyone, >>>>>>> > > > >>>>>>> > > > Thanks for your responses, i understand communicating on this >>>>>>> way to this level of technicality can be hard, i still think we can work >>>>>>> ways to solve this problem though, >>>>>>> > > > >>>>>>> > > > I can say the following at this point: >>>>>>> > > > >>>>>>> > > > ? Program works without issues in any other non-gpu >>>>>>> preconditioner, just by calling -pc_type ### . >>>>>>> > > > ? Program works correctly with ViennaCL preconditioners >>>>>>> with mpirun -n 1, that is on one processor. >>>>>>> > > > ? Program breaks with every ViennaCL preconditioner when >>>>>>> attempting any more than 1 processors. >>>>>>> > > > ? I haven't tried other GPU preconditioners because >>>>>>> ViennaCL gave the best performance in 1 processor before. >>>>>>> > > > ? I have made sure the matrix type is mpiaijviennacl as >>>>>>> it is printed right before the error log. >>>>>>> > > > ? I am attaching what i think are the backtrace logs of >>>>>>> the run with two cores, as i have limited experience with this kind of >>>>>>> debugging, and i cannot make sense of what they say, please let me know if >>>>>>> you need me to do something else. >>>>>>> > > > >>>>>>> > > > Current options i can think of are giving you permission to >>>>>>> clone my model repo, or for you to guide me trough the process remotely, >>>>>>> > > > >>>>>>> > > > Thanks, >>>>>>> > > > >>>>>>> > > > .-.-.-.- >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > The error i get is still: >>>>>>> > > > >>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>> >>>>>>> > > > Of sizes: 125 x 125 >>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>> >>>>>>> > > > Of sizes: 125 x 125 >>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>> -------------------------------------------------------------- >>>>>>> > > > [0]PETSC ERROR: No support for this operation for this object >>>>>>> type >>>>>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>>> > > > [0]PETSC ERROR: See >>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>> shooting. >>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>> > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>>>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>>> > > > [1]PETSC ERROR: >>>>>>> ------------------------------------------------------------------------ >>>>>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>>>> Violation, probably memory access out of range >>>>>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>>>>> /home/valera/petsc/src/sys/error/err.c >>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>> > > > [1]PETSC ERROR: [1] KSPSetUp line 294 >>>>>>> /home/valera/petsc/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 Development GIT revision: >>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown >>>>>>> file >>>>>>> > > > >>>>>>> -------------------------------------------------------------------------- >>>>>>> > > > MPI_ABORT was invoked on rank 1 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. >>>>>>> > > > >>>>>>> -------------------------------------------------------------------------- >>>>>>> > > > [0]PETSC ERROR: >>>>>>> ------------------------------------------------------------------------ >>>>>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some >>>>>>> process (or the batch system) has told this process to end >>>>>>> > > > [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. >>>>>>> > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 >>>>>>> /home/valera/petsc/src/mat/utils/gcreate.c >>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>> > > > [0]PETSC ERROR: [0] KSPSetUp line 294 >>>>>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>> -------------------------------------------------------------- >>>>>>> > > > [0]PETSC ERROR: Signal received >>>>>>> > > > [0]PETSC ERROR: See >>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>> shooting. >>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>> > > > [0]PETSC ERROR: #4 User provided function() line 0 in unknown >>>>>>> file >>>>>>> > > > [node50:32783] 1 more process has sent help message >>>>>>> help-mpi-api.txt / mpi-abort >>>>>>> > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" to >>>>>>> 0 to see all help / error messages >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp < >>>>>>> rupp at iue.tuwien.ac.at> wrote: >>>>>>> > > > Hi Manuel, >>>>>>> > > > >>>>>>> > > > as Barry said, it is hard for us to provide any help without >>>>>>> having a more complete picture of what is going on. >>>>>>> > > > >>>>>>> > > > The error you report seems to come from the AMG preconditioner >>>>>>> in ViennaCL. This can have many origins. Do other preconditioners run >>>>>>> without error? Can you run in a debugger and provide a complete backtrace? >>>>>>> > > > >>>>>>> > > > Thanks and best regards, >>>>>>> > > > Karli >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: >>>>>>> > > > Talked too fast, >>>>>>> > > > >>>>>>> > > > After fixing that problem, i tried more than one mpi processor >>>>>>> and got the following: >>>>>>> > > > >>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>> > > > Of sizes: 125 x 125 >>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>> > > > Of sizes: 125 x 125 >>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>> -------------------------------------------------------------- >>>>>>> > > > [0]PETSC ERROR: No support for this operation for this object >>>>>>> type >>>>>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>>> > > > [0]PETSC ERROR: See >>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>> shooting. >>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >>>>>>> http://saviennacl.cu> >>>>>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>> > > > [1]PETSC ERROR: >>>>>>> ------------------------------------------------------------------------ >>>>>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>>>> Violation, probably memory access out of range >>>>>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>>>>> /home/valera/petsc/src/sys/error/err.c >>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>>>>> http://saviennacl.cu> >>>>>>> > > > >>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: >>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in unknown >>>>>>> file >>>>>>> > > > >>>>>>> -------------------------------------------------------------------------- >>>>>>> > > > MPI_ABORT was invoked on rank 1 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. >>>>>>> > > > >>>>>>> -------------------------------------------------------------------------- >>>>>>> > > > [0]PETSC ERROR: >>>>>>> ------------------------------------------------------------------------ >>>>>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some >>>>>>> process (or the batch system) has told this process to end >>>>>>> > > > [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. >>>>>>> > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>>>>> /home/valera/petsc/src/sys/objects/tagm.c >>>>>>> > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >>>>>>> /home/valera/petsc/src/sys/objects/inherit.c >>>>>>> > > > [0]PETSC ERROR: [0] ISCreate line 35 >>>>>>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>>>>>> > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 >>>>>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>>>>> http://saviennacl.cu> >>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>> -------------------------------------------------------------- >>>>>>> > > > [0]PETSC ERROR: Signal received >>>>>>> > > > [0]PETSC ERROR: See >>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>> shooting. >>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>> > > > [0]PETSC ERROR: #3 User provided function() line 0 in unknown >>>>>>> file >>>>>>> > > > [node50:30582] 1 more process has sent help message >>>>>>> help-mpi-api.txt / mpi-abort >>>>>>> > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" to >>>>>>> 0 to see all help / error messages >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > It is currently running in 1 mpi processor + GPU but i would >>>>>>> like to call at least 16 mpi processors + GPU to do the rest of the data >>>>>>> management who is not part of the main laplacian on the mpi and the >>>>>>> laplacian solution on the GPU, is this currently possible? >>>>>>> > > > >>>>>>> > > > Thanks for your help, >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera < >>>>>>> mvalera-w at sdsu.edu > wrote: >>>>>>> > > > >>>>>>> > > > Ok, i found the culprit and we can close this thread, >>>>>>> > > > >>>>>>> > > > The problem was a missing variable for setting the maximum >>>>>>> columns, >>>>>>> > > > which i deleted at some point without realizing. The error >>>>>>> message >>>>>>> > > > was too ambiguous to catch this so i had to compare with a >>>>>>> previous >>>>>>> > > > working version of the arguments of MatSetValues, it was >>>>>>> evident then. >>>>>>> > > > >>>>>>> > > > Good news is that i can now set the values with the >>>>>>> viennacl types too, >>>>>>> > > > >>>>>>> > > > Thanks for your kind help, >>>>>>> > > > >>>>>>> > > > Manuel >>>>>>> > > > >>>>>>> > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >>>>>>> > > > > wrote: >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > 1) PetscMalloc() is never valid or needed in >>>>>>> Fortran >>>>>>> > > > >>>>>>> > > > 2) there is no reason to use >>>>>>> DMSetMatrixPreallocateOnly() >>>>>>> > > > just use DMCreateMatrix() assuming that using a DM >>>>>>> (DMDA, >>>>>>> > > > DMPLEX, etc) is suitable for your problem. >>>>>>> > > > >>>>>>> > > > At this end we are totally guessing at what you >>>>>>> are doing >>>>>>> > > > and so have little help we can provide. A simple, >>>>>>> nonworking >>>>>>> > > > code that tries to do what you would need would help >>>>>>> us a great >>>>>>> > > > deal in understanding that you are trying to do. >>>>>>> > > > >>>>>>> > > > Barry >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera >>>>>>> > > > > >>>>>>> wrote: >>>>>>> > > > > >>>>>>> > > > > Matthew, PetscMalloc gives the same error, >>>>>>> > > > > >>>>>>> > > > > Barry, it would be very hard for me to get the code >>>>>>> to a >>>>>>> > > > minimum working example, i guess all i need to >>>>>>> understand is how >>>>>>> > > > to setup a DM matrix with DMSetMatrixPreallocateOnly() >>>>>>> instead >>>>>>> > > > of MatMPIAIJSetPreallocation() as we were doing >>>>>>> before, is there >>>>>>> > > > a simple example who does this in Fortran? >>>>>>> > > > > >>>>>>> > > > > Is the PetscMalloc call needed? is 'call >>>>>>> > > > PetscMalloc(1,row,ierr)' a valid, compilable call to >>>>>>> > > > PetscMalloc? what other reason may there be for this >>>>>>> error to >>>>>>> > > > happen ? >>>>>>> > > > > >>>>>>> > > > > Just remembering, that trying to setup the matrix >>>>>>> with the >>>>>>> > > > MatAIJSetPreallocation() brings up an error to >>>>>>> acknowledge the >>>>>>> > > > viennacl datatypes and that's why i'm trying to make >>>>>>> this change >>>>>>> > > > on your recommendation, >>>>>>> > > > > >>>>>>> > > > > Thanks for your help, >>>>>>> > > > > >>>>>>> > > > > >>>>>>> > > > > >>>>>>> > > > > >>>>>>> > > > > >>>>>>> > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >>>>>>> > > > > >>>>>>> wrote: >>>>>>> > > > > >>>>>>> > > > > Send your code in a way we can compile and run >>>>>>> it; it must >>>>>>> > > > be some simple issue that is hard to communicate in >>>>>>> email. >>>>>>> > > > > >>>>>>> > > > > Barry >>>>>>> > > > > >>>>>>> > > > > >>>>>>> > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >>>>>>> > > > > >>>>>>> wrote: >>>>>>> > > > > > >>>>>>> > > > > > Hello everyone, >>>>>>> > > > > > >>>>>>> > > > > > I just had time to work on this again, and >>>>>>> checked the code >>>>>>> > > > for errors on the matrix entries, this is the exact >>>>>>> code i was >>>>>>> > > > using for creating the matrix without >>>>>>> > > > DMSetMatrixPreallocateOnly, using >>>>>>> MatMPIAIJSetPreallocation and >>>>>>> > > > it worked that way, but trying this way i get the same >>>>>>> 'Column >>>>>>> > > > too large' error using any number at the column >>>>>>> position of >>>>>>> > > > MatSetValues, >>>>>>> > > > > > >>>>>>> > > > > > I have set up my code to print the column >>>>>>> argument (n) of >>>>>>> > > > MatSetValues and in this case is 7 (lower than 124), >>>>>>> it still >>>>>>> > > > gives error, even entering a specific number in the >>>>>>> MatSetValues >>>>>>> > > > column argument position gives the same error. >>>>>>> > > > > > >>>>>>> > > > > > So next i went back to ex.50 here: >>>>>>> > > > >>>>>>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html >>>>>>> > > > < >>>>>>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html >>>>>>> > >>>>>>> > > > and it has a very similar structure except the >>>>>>> PetscMalloc1() >>>>>>> > > > call, so i tried adding that and got: >>>>>>> > > > > > >>>>>>> > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: >>>>>>> undefined >>>>>>> > > > reference to `petscmalloc1_' >>>>>>> > > > > > >>>>>>> > > > > > Any ideas on this behaviour? >>>>>>> > > > > > >>>>>>> > > > > > Thanks so much, >>>>>>> > > > > > >>>>>>> > > > > > >>>>>>> > > > > > >>>>>>> > > > > > >>>>>>> > > > > > >>>>>>> > > > > > >>>>>>> > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >>>>>>> > > > > >>>>>>> wrote: >>>>>>> > > > > > >>>>>>> > > > > > Column too large: col 10980 max 124 >>>>>>> > > > > > >>>>>>> > > > > > You need to check the code that is generating >>>>>>> the matrix >>>>>>> > > > entries. The matrix has 124 columns but you are >>>>>>> attempting to >>>>>>> > > > put a value at column 10980 >>>>>>> > > > > > >>>>>>> > > > > > Barry >>>>>>> > > > > > >>>>>>> > > > > > >>>>>>> > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >>>>>>> > > > > >>>>>>> wrote: >>>>>>> > > > > > > >>>>>>> > > > > > > Thanks Matthew and Barry, >>>>>>> > > > > > > >>>>>>> > > > > > > Now my code looks like: >>>>>>> > > > > > > >>>>>>> > > > > > > call >>>>>>> DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>>>>>> > > > > > > call >>>>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>> > > > > > > call MatSetFromOptions(A,ierr) >>>>>>> > > > > > > call MatSetUp(A,ierr) >>>>>>> > > > > > > [...] >>>>>>> > > > > > > call >>>>>>> > > > >>>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>> > > > > > > [...] >>>>>>> > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, >>>>>>> ierr) >>>>>>> > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, ierr) >>>>>>> > > > > > > >>>>>>> > > > > > > And i get a different error, now is: >>>>>>> > > > > > > >>>>>>> > > > > > > [0]PETSC ERROR: --------------------- Error >>>>>>> Message >>>>>>> > > > >>>>>>> -------------------------------------------------------------- >>>>>>> > > > > > > [0]PETSC ERROR: Argument out of range >>>>>>> > > > > > > [0]PETSC ERROR: Column too large: col 10980 max >>>>>>> 124 >>>>>>> > > > > > > [0]PETSC ERROR: See >>>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>>> > > > >>>>>>> for >>>>>>> > > > trouble shooting. >>>>>>> > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 >>>>>>> +0300 >>>>>>> > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>>>> named node50 >>>>>>> > > > by valera Wed Aug 15 19:40:00 2018 >>>>>>> > > > > > > [0]PETSC ERROR: Configure options >>>>>>> PETSC_ARCH=cuda-debug >>>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>>> --with-shared-libraries=1 >>>>>>> > > > --with-debugging=1 --with-cuda=1 >>>>>>> --CUDAFLAGS=-arch=sm_60 >>>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>> > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line >>>>>>> 442 in >>>>>>> > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c >>>>>>> > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > Thanks again, >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry F. >>>>>>> > > > > >>>>>>> wrote: >>>>>>> > > > > > > >>>>>>> > > > > > > Should be >>>>>>> > > > > > > >>>>>>> > > > > > > call >>>>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>> > > > > > > >>>>>>> > > > > > > and remove the rest. You need to set the type >>>>>>> of Mat >>>>>>> > > > you want the DM to return BEFORE you create the matrix. >>>>>>> > > > > > > >>>>>>> > > > > > > Barry >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >>>>>>> > > > > >>>>>>> wrote: >>>>>>> > > > > > > > >>>>>>> > > > > > > > Ok thanks for clarifying that, i wasn't sure >>>>>>> if there >>>>>>> > > > were different types, >>>>>>> > > > > > > > >>>>>>> > > > > > > > Here is a stripped down version of my code, >>>>>>> it seems >>>>>>> > > > like the preallocation is working now since the matrix >>>>>>> > > > population part is working without problem, but here >>>>>>> it is for >>>>>>> > > > illustration purposes: >>>>>>> > > > > > > > >>>>>>> > > > > > > > call >>>>>>> DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>>>>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>>>>> > > > > > > > call >>>>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>>> > > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>> > > > > > > > call >>>>>>> > > > >>>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>>> > > > > > > > call MatSetUp(A,ierr) >>>>>>> > > > > > > > [...] >>>>>>> > > > > > > > call >>>>>>> > > > >>>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>> > > > > > > > [...] >>>>>>> > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, >>>>>>> ierr) >>>>>>> > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, >>>>>>> ierr) >>>>>>> > > > > > > > >>>>>>> > > > > > > > Adding the first line there did the trick, >>>>>>> > > > > > > > >>>>>>> > > > > > > > Now the problem seems to be the program is not >>>>>>> > > > recognizing the matrix as ViennaCL type when i try >>>>>>> with more >>>>>>> > > > than one processor, i get now: >>>>>>> > > > > > > > >>>>>>> > > > > > > > [0]PETSC ERROR: --------------------- Error >>>>>>> Message >>>>>>> > > > >>>>>>> -------------------------------------------------------------- >>>>>>> > > > > > > > [0]PETSC ERROR: No support for this operation >>>>>>> for this >>>>>>> > > > object type >>>>>>> > > > > > > > [0]PETSC ERROR: Currently only handles >>>>>>> ViennaCL matrices >>>>>>> > > > > > > > [0]PETSC ERROR: See >>>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>>> > > > >>>>>>> for >>>>>>> > > > trouble shooting. >>>>>>> > > > > > > > [0]PETSC ERROR: Petsc Development GIT >>>>>>> revision: >>>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 >>>>>>> +0300 >>>>>>> > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>>>> named >>>>>>> > > > node50 by valera Wed Aug 15 14:44:22 2018 >>>>>>> > > > > > > > [0]PETSC ERROR: Configure options >>>>>>> PETSC_ARCH=cuda-debug >>>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>>> --with-shared-libraries=1 >>>>>>> > > > --with-debugging=1 --with-cuda=1 >>>>>>> --CUDAFLAGS=-arch=sm_60 >>>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>> > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line >>>>>>> 47 in >>>>>>> > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/ >>>>>>> saviennacl.cu >>>>>>> > > > >>>>>>> > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>> > > > /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>> > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>>>>> > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>>> > > > > > > > >>>>>>> > > > > > > > When running with: >>>>>>> > > > > > > > >>>>>>> > > > > > > > mpirun -n 1 ./gcmLEP.GPU >>>>>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ >>>>>>> jid=tiny_cuda_test_n2 >>>>>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>>>> aijviennacl >>>>>>> > > > -pc_type saviennacl -log_view >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > Thanks, >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew >>>>>>> Knepley >>>>>>> > > > > wrote: >>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >>>>>>> > > > > >>>>>>> wrote: >>>>>>> > > > > > > > It seems to be resumed on: I do not know how >>>>>>> to >>>>>>> > > > preallocate a DM Matrix correctly. >>>>>>> > > > > > > > >>>>>>> > > > > > > > There is only one matrix type, Mat. There are >>>>>>> no >>>>>>> > > > separate DM matrices. A DM can create a matrix for you >>>>>>> > > > > > > > using DMCreateMatrix(), but that is a Mat and >>>>>>> it is >>>>>>> > > > preallocated correctly. I am not sure what you are >>>>>>> doing. >>>>>>> > > > > > > > >>>>>>> > > > > > > > Thanks, >>>>>>> > > > > > > > >>>>>>> > > > > > > > Matt >>>>>>> > > > > > > > >>>>>>> > > > > > > > The interesting part is that it only breaks >>>>>>> when i need >>>>>>> > > > to populate a GPU matrix from MPI, so kudos on that, >>>>>>> but it >>>>>>> > > > seems i need to do better on my code to get this setup >>>>>>> working, >>>>>>> > > > > > > > >>>>>>> > > > > > > > Any help would be appreciated, >>>>>>> > > > > > > > >>>>>>> > > > > > > > Thanks, >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew >>>>>>> Knepley >>>>>>> > > > > wrote: >>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >>>>>>> > > > > >>>>>>> wrote: >>>>>>> > > > > > > > Thanks Matthew, >>>>>>> > > > > > > > >>>>>>> > > > > > > > I try to do that when calling: >>>>>>> > > > > > > > >>>>>>> > > > > > > > call >>>>>>> > > > >>>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>>> > > > > > > > >>>>>>> > > > > > > > But i am not aware on how to do this for the >>>>>>> DM if it >>>>>>> > > > needs something more specific/different, >>>>>>> > > > > > > > >>>>>>> > > > > > > > The error says that your preallocation is >>>>>>> wrong for the >>>>>>> > > > values you are putting in. The DM does not control >>>>>>> either, >>>>>>> > > > > > > > so I do not understand your email. >>>>>>> > > > > > > > >>>>>>> > > > > > > > Thanks, >>>>>>> > > > > > > > >>>>>>> > > > > > > > Matt >>>>>>> > > > > > > > >>>>>>> > > > > > > > Thanks, >>>>>>> > > > > > > > >>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew >>>>>>> Knepley >>>>>>> > > > > wrote: >>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>>>>>> > > > > >>>>>>> wrote: >>>>>>> > > > > > > > Hello PETSc devs, >>>>>>> > > > > > > > >>>>>>> > > > > > > > I am running into an error when trying to use >>>>>>> the >>>>>>> > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same >>>>>>> code runs >>>>>>> > > > for MATSEQAIJVIENNACL type in one processor. The error >>>>>>> happens >>>>>>> > > > when calling MatSetValues for this specific >>>>>>> configuration. It >>>>>>> > > > does not occur when using MPI DMMatrix types only. >>>>>>> > > > > > > > >>>>>>> > > > > > > > The DM properly preallocates the matrix. I am >>>>>>> assuming >>>>>>> > > > you do not here. >>>>>>> > > > > > > > >>>>>>> > > > > > > > Matt >>>>>>> > > > > > > > >>>>>>> > > > > > > > Any help will be appreciated, >>>>>>> > > > > > > > >>>>>>> > > > > > > > Thanks, >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > My program call: >>>>>>> > > > > > > > >>>>>>> > > > > > > > mpirun -n 2 ./gcmLEP.GPU >>>>>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ >>>>>>> jid=tiny_cuda_test_n2 >>>>>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>>>> aijviennacl >>>>>>> > > > -pc_type saviennacl -log_view >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > The error (repeats after each MatSetValues >>>>>>> call): >>>>>>> > > > > > > > >>>>>>> > > > > > > > [1]PETSC ERROR: --------------------- Error >>>>>>> Message >>>>>>> > > > >>>>>>> -------------------------------------------------------------- >>>>>>> > > > > > > > [1]PETSC ERROR: Argument out of range >>>>>>> > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at >>>>>>> global >>>>>>> > > > row/column (75, 50) into matrix >>>>>>> > > > > > > > [1]PETSC ERROR: See >>>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>>> > > > >>>>>>> for >>>>>>> > > > trouble shooting. >>>>>>> > > > > > > > [1]PETSC ERROR: Petsc Development GIT >>>>>>> revision: >>>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 >>>>>>> +0300 >>>>>>> > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>>>> named >>>>>>> > > > node50 by valera Wed Aug 15 13:10:44 2018 >>>>>>> > > > > > > > [1]PETSC ERROR: Configure options >>>>>>> PETSC_ARCH=cuda-debug >>>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>>> --with-shared-libraries=1 >>>>>>> > > > --with-debugging=1 --with-cuda=1 >>>>>>> --CUDAFLAGS=-arch=sm_60 >>>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>> > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() line >>>>>>> 608 in >>>>>>> > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>>>>>> > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > My Code structure: >>>>>>> > > > > > > > >>>>>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>>>>> > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, >>>>>>> numprocs, ierr) >>>>>>> > > > > > > > if (numprocs > 1) then ! set matrix type >>>>>>> parallel >>>>>>> > > > > > > > ! Get local size >>>>>>> > > > > > > > call >>>>>>> DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>>>>>> > > > > > > > call VecGetLocalSize(Tmpnat,locsize,ierr) >>>>>>> > > > > > > > call VecDestroy(Tmpnat,ierr) >>>>>>> > > > > > > > ! Set matrix >>>>>>> > > > > > > > #ifdef GPU >>>>>>> > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >>>>>>> > > > > > > > call >>>>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>>> > > > > > > > call >>>>>>> DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>> > > > > > > > print*,'SETTING GPU TYPES' >>>>>>> > > > > > > > #else >>>>>>> > > > > > > > call DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>>>>> > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) >>>>>>> > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! >>>>>>> > > > > > > > #endif >>>>>>> > > > > > > > call >>>>>>> > > > >>>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>>> > > > > > > > else ! set matrix type >>>>>>> sequential >>>>>>> > > > > > > > #ifdef GPU >>>>>>> > > > > > > > call >>>>>>> DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>>>>>> > > > > > > > call >>>>>>> DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>>>>>> > > > > > > > call MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>>>>> > > > > > > > print*,'SETTING GPU TYPES' >>>>>>> > > > > > > > #else >>>>>>> > > > > > > > call DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>>>>> > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >>>>>>> > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) >>>>>>> > > > > > > > #endif >>>>>>> > > > > > > > call MatSetUp(A,ierr) >>>>>>> > > > > > > > call >>>>>>> > > > >>>>>>> getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>>>>> > > > > > > > >>>>>>> > > > > > > > do k=zstart,zend-1 >>>>>>> > > > > > > > do j=ystart,yend-1 >>>>>>> > > > > > > > do i=xstart,xend-1 >>>>>>> > > > > > > > [..] >>>>>>> > > > > > > > call >>>>>>> > > > >>>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>> > > > > > > > [..] >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > -- >>>>>>> > > > > > > > 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 >>>>>>> > > > > > > > >>>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>>> > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > -- >>>>>>> > > > > > > > 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 >>>>>>> > > > > > > > >>>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>>> > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > > -- >>>>>>> > > > > > > > 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 >>>>>>> > > > > > > > >>>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>>> > > > >>>>>>> > > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > > >>>>>>> > > > > > >>>>>>> > > > > > >>>>>>> > > > > >>>>>>> > > > > >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > >>>>>>> > > > >>>>>>> > >>>>>>> > >>>>>>> > >>>>>>> >>>>>>> >>>>>> >>>>> >>>> >>>> -- >>>> 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 >>>> >>>> https://www.cse.buffalo.edu/~knepley/ >>>> >>>> >>> >>> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> >> > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Thu Aug 30 10:34:58 2018 From: jed at jedbrown.org (Jed Brown) Date: Thu, 30 Aug 2018 09:34:58 -0600 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: <87in3rookd.fsf@jedbrown.org> Manuel Valera writes: > I thought newer NVIDIA cards had integrated circuits, not using PCI > anymore, still the same case? NVLink is much faster than PCI, but it's still a bus that is slower (and higher latency) than aggregate DDR, though there are open questions about how much message packing (for example) should take place on GPU versus CPU. From Ling.Zou at inl.gov Thu Aug 30 10:46:31 2018 From: Ling.Zou at inl.gov (Ling Zou) Date: Thu, 30 Aug 2018 15:46:31 +0000 Subject: [petsc-users] Problem with SNES convergence In-Reply-To: <1135178798.714456.1535603850997@mail.yahoo.com> References: <1371398831.496454.1535553418412.ref@mail.yahoo.com> <1371398831.496454.1535553418412@mail.yahoo.com> <387994F6-79FF-4DE4-8375-B24F63B0F332@anl.gov>, <1135178798.714456.1535603850997@mail.yahoo.com> Message-ID: Rahul, please see the logic I used to reduce time step size. Hope this helps you. Ling for (timestep = 1; timestep <= N; timestep++) // loop over time steps { // before trying to solve a time step, 1) it is still not successful; 2) we are not giving up; 3) haven't failed yet bool give_up = false; bool success = false; bool experienced_fail_this_time_step = false; // save solutions and old solutions into u_copy and u_old_copy, in case a time step fails and we restart from this saved solutions VecCopy(u, u_copy); VecCopy(u_old, u_old_copy); while ((!give_up) && (!success)) // as long as not successful and not giving up, we solve again with smaller time step { if (time_step_size < dt_min) { give_up = true; break; } // ok, bad luck, give up due to time step size smaller than a preset value if (experienced_fail_this_time_step) { // get the vectors from backups if this is a re-try, i.e., already failed with a larger time step VecCopy(u_old_copy, u); VecCopy(u_old_copy, u_old); } try { SNESSolve(snes, NULL, u); SNESGetConvergedReason(snes, &snes_converged_reason); if (snes_converged_reason > 0) success = true; // yes, snes converged else { // no, snes did not converge cutTimeStepSize(); // e.g., dt / 2 experienced_fail_this_time_step = true; } } catch (int err) { // in case your own pieces of code throws an exception std::cout << "An exception occurred." << std::endl; success = false; cutTimeStepSize(); // e.g., dt / 2 experienced_fail_this_time_step = true; } } if (success) { // output, print, whatever // duplicate current solution to old solution in preparing next time step VecCopy(u, u_old); // you can increase time step size here, e.g. * 2 increaseTimeStepSize(); } if (give_up) { simulationFailed = true; std::cerr << "Simulation failed.\n"; //exit(1);// dont exit(1) now, just break the for-loop, let PETSc clean its workspace. break; } } ________________________________ From: Rahul Samala Sent: Wednesday, August 29, 2018 10:37:30 PM To: Ling Zou; Smith, Barry F. Cc: PETSc Users List Subject: Re: [petsc-users] Problem with SNES convergence Thank you Ling, I would definitely like to look at your code for reducing timestep size. Thank you Barry for your inputs. -- Rahul. On Wednesday, August 29, 2018, 9:02:00 PM GMT+5:30, Smith, Barry F. wrote: Current time (before start of timestep) 52.5048, iter=5380 Timestep=864.000000 0 SNES Function norm 1.650467412595e+05 0 KSP preconditioned resid norm 3.979123221160e+03 true resid norm 1.650467412595e+05 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 9.178246525982e-11 true resid norm 7.006473307032e-09 ||r(i)||/||b|| 4.245144892632e-14 Linear solve converged due to CONVERGED_RTOL iterations 1 1 SNES Function norm 6.722712947273e+02 Linear solve did not converge due to DIVERGED_NANORINF iterations 0 Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 1 This usually is an indicator that the LU (ILU) factorization has hit a zero pivot (hence the linear solve has a divide by zero so gives the DIVERGED_NANORINF flag). You can/should call SNESGetConvergedReason() immediately after each SNESSolve(), if the result is negative that means something has failed in the nonlinear solve and you can try cutting the time-step and trying again. Good luck, Barry > On Aug 29, 2018, at 10:11 AM, Ling Zou > wrote: > > 1) My experience is that this kind of bug or sudden death (everything is fine till suddenly something is broken) is very difficult to debug/fix. I looked at your txt files and could not give any quick comments. Maybe PETSc developers have better idea on this. > 2) I do have successful experience on reducing time step size when PETSc fails solving or my own piece of code throws an exception. If you are interested, I can share them. > > -Ling > From: petsc-users > on behalf of Rahul Samala > > Sent: Wednesday, August 29, 2018 8:36:58 AM > To: PETSc Users List > Subject: [petsc-users] Problem with SNES convergence > > Hello PetSc users, > > 1) I have problem with SNES convergence. I call SNESSolve in a time loop and use the inbuilt Jacobian feature. The code works fine for about 5380 time steps after which it breaks down. The solution till that point looks fine. I have used newtonls of type l2. (newtontr and others aren't working). Since I have used inbuilt Jacobian feature and the code worked for about 5000 time steps I don't understand the reason for failure, is it an incorrect function evaluation? Attached are the outputs with -pc_type lu and ilu along with -snes_linesearch_type l2 -snes_converged_reason -snes_monitor -snes_view -ksp_converged_reason -ksp_monitor_true_residual > > 2) How to get hold of failure signal, like Nonlinear solve DIVERGED_MAX_IT or DIVERGED_LINEAR_SOLVE so that whenever it occurs I can use a reduced time step and see if the code converges. > > Thank you, > Rahul. > > output_ilu.txt > > > output_ilu.txt > > > > output_lu.txt > > > output_lu.txt -------------- next part -------------- An HTML attachment was scrubbed... URL: From huq2090 at gmail.com Thu Aug 30 10:50:33 2018 From: huq2090 at gmail.com (Fazlul Huq) Date: Thu, 30 Aug 2018 10:50:33 -0500 Subject: [petsc-users] Integration of hyper & trilinos In-Reply-To: <87va7ror2q.fsf@jedbrown.org> References: <87va7ror2q.fsf@jedbrown.org> Message-ID: I have run: jimmy at dave:~/projects/petsc$ ./configure --download-hyper & jimmy at dave:~/projects/petsc$ ./configure --download-ml At the end I got following message: xxx=========================================================================xxx Configure stage complete. Now build PETSc libraries with (gnumake build): make PETSC_DIR=/home/jimmy/projects/petsc PETSC_ARCH=arch-linux2-c-debug all xxx=========================================================================xxx Am I ready to use it now or do I need no make it first? Or do I need to edit .bashrc file with, export PETSC_DIR=/home/jimmy/projects/petsc & export PETSC_ARCH=arch-linux2-c-debug all And then run make from command window? Thanks. Huq On Thu, Aug 30, 2018 at 9:40 AM Jed Brown wrote: > You would configure PETSc with --download-hypre and --download-ml (this > part of Trilinos can be installed on its own). Then run your > application with run-time options like -pc_type hypre or -pc_type ml. > See the user's manual and/or tutorials. > > Fazlul Huq writes: > > > Hello Petsc developers, > > > > 1. I want to integrate petsc with hyper and trilinos cause I want to > solve > > some problems using multigrid. I know, I need to download and install > > both of them and then configure petsc with hyper and trilinos to use them > > with petsc. But, I don't know how to configure petsc with hyper and > > trilinos or any other package. Is it like, running some command from > > terminal or editing .bashrc file? Currently, this is the .bashrc file > > regarding petsc in my desktop: > > > > export PETSC_DIR=/home/jimmy/projects/petsc > > > > 2. Can I use c programming routine in petsc code and make and run it? If > > yes then what is the procedure? Last day I tried to do that but I got > error > > message while making the file. > > > > Thanks. > > > > -- > > > > Fazlul Huq > > Graduate Research Assistant > > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > > University of Illinois at Urbana-Champaign (UIUC) > > E-mail: huq2090 at gmail.com > -- Fazlul Huq Graduate Research Assistant Department of Nuclear, Plasma & Radiological Engineering (NPRE) University of Illinois at Urbana-Champaign (UIUC) E-mail: huq2090 at gmail.com -------------- next part -------------- An HTML attachment was scrubbed... URL: From balay at mcs.anl.gov Thu Aug 30 10:55:02 2018 From: balay at mcs.anl.gov (Satish Balay) Date: Thu, 30 Aug 2018 10:55:02 -0500 Subject: [petsc-users] Integration of hyper & trilinos In-Reply-To: References: <87va7ror2q.fsf@jedbrown.org> Message-ID: Its: ./configure --download-ml --download-hypre make PETSC_DIR=/home/jimmy/projects/petsc PETSC_ARCH=arch-linux2-c-debug all Setting up .bashrc is optional. Its a shortcut to avoid specifing PETSC_ARCH and PETSC_DIR options to make [above] Satish On Thu, 30 Aug 2018, Fazlul Huq wrote: > I have run: > > jimmy at dave:~/projects/petsc$ ./configure --download-hyper > & > jimmy at dave:~/projects/petsc$ ./configure --download-ml > > At the end I got following message: > > xxx=========================================================================xxx > Configure stage complete. Now build PETSc libraries with (gnumake build): > make PETSC_DIR=/home/jimmy/projects/petsc PETSC_ARCH=arch-linux2-c-debug > all > xxx=========================================================================xxx > > Am I ready to use it now or do I need no make it first? > Or do I need to edit .bashrc file with, > > export PETSC_DIR=/home/jimmy/projects/petsc > & > export PETSC_ARCH=arch-linux2-c-debug all > > And then run make from command window? > > Thanks. > Huq > > > On Thu, Aug 30, 2018 at 9:40 AM Jed Brown wrote: > > > You would configure PETSc with --download-hypre and --download-ml (this > > part of Trilinos can be installed on its own). Then run your > > application with run-time options like -pc_type hypre or -pc_type ml. > > See the user's manual and/or tutorials. > > > > Fazlul Huq writes: > > > > > Hello Petsc developers, > > > > > > 1. I want to integrate petsc with hyper and trilinos cause I want to > > solve > > > some problems using multigrid. I know, I need to download and install > > > both of them and then configure petsc with hyper and trilinos to use them > > > with petsc. But, I don't know how to configure petsc with hyper and > > > trilinos or any other package. Is it like, running some command from > > > terminal or editing .bashrc file? Currently, this is the .bashrc file > > > regarding petsc in my desktop: > > > > > > export PETSC_DIR=/home/jimmy/projects/petsc > > > > > > 2. Can I use c programming routine in petsc code and make and run it? If > > > yes then what is the procedure? Last day I tried to do that but I got > > error > > > message while making the file. > > > > > > Thanks. > > > > > > -- > > > > > > Fazlul Huq > > > Graduate Research Assistant > > > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > > > University of Illinois at Urbana-Champaign (UIUC) > > > E-mail: huq2090 at gmail.com > > > > > From jed at jedbrown.org Thu Aug 30 10:55:28 2018 From: jed at jedbrown.org (Jed Brown) Date: Thu, 30 Aug 2018 09:55:28 -0600 Subject: [petsc-users] Integration of hyper & trilinos In-Reply-To: References: <87va7ror2q.fsf@jedbrown.org> Message-ID: <87ftyvonm7.fsf@jedbrown.org> Fazlul Huq writes: > I have run: > > jimmy at dave:~/projects/petsc$ ./configure --download-hyper > & > jimmy at dave:~/projects/petsc$ ./configure --download-ml The package name is hypre, not hyper. And you need to pass both at once if you want both libraries to be available. > At the end I got following message: > > xxx=========================================================================xxx > Configure stage complete. Now build PETSc libraries with (gnumake build): > make PETSC_DIR=/home/jimmy/projects/petsc PETSC_ARCH=arch-linux2-c-debug > all > xxx=========================================================================xxx > > Am I ready to use it now or do I need no make it first? As the message says, you need to issue that command to build. > Or do I need to edit .bashrc file with, > > export PETSC_DIR=/home/jimmy/projects/petsc > & > export PETSC_ARCH=arch-linux2-c-debug all > > And then run make from command window? > > Thanks. > Huq > > > On Thu, Aug 30, 2018 at 9:40 AM Jed Brown wrote: > >> You would configure PETSc with --download-hypre and --download-ml (this >> part of Trilinos can be installed on its own). Then run your >> application with run-time options like -pc_type hypre or -pc_type ml. >> See the user's manual and/or tutorials. >> >> Fazlul Huq writes: >> >> > Hello Petsc developers, >> > >> > 1. I want to integrate petsc with hyper and trilinos cause I want to >> solve >> > some problems using multigrid. I know, I need to download and install >> > both of them and then configure petsc with hyper and trilinos to use them >> > with petsc. But, I don't know how to configure petsc with hyper and >> > trilinos or any other package. Is it like, running some command from >> > terminal or editing .bashrc file? Currently, this is the .bashrc file >> > regarding petsc in my desktop: >> > >> > export PETSC_DIR=/home/jimmy/projects/petsc >> > >> > 2. Can I use c programming routine in petsc code and make and run it? If >> > yes then what is the procedure? Last day I tried to do that but I got >> error >> > message while making the file. >> > >> > Thanks. >> > >> > -- >> > >> > Fazlul Huq >> > Graduate Research Assistant >> > Department of Nuclear, Plasma & Radiological Engineering (NPRE) >> > University of Illinois at Urbana-Champaign (UIUC) >> > E-mail: huq2090 at gmail.com >> > > > -- > > Fazlul Huq > Graduate Research Assistant > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > University of Illinois at Urbana-Champaign (UIUC) > E-mail: huq2090 at gmail.com From huq2090 at gmail.com Thu Aug 30 10:59:41 2018 From: huq2090 at gmail.com (Fazlul Huq) Date: Thu, 30 Aug 2018 10:59:41 -0500 Subject: [petsc-users] Integration of hyper & trilinos In-Reply-To: <87ftyvonm7.fsf@jedbrown.org> References: <87va7ror2q.fsf@jedbrown.org> <87ftyvonm7.fsf@jedbrown.org> Message-ID: I did that and I got the following error: **************************ERROR************************************* Error during compile, check arch-linux2-c-debug/lib/petsc/conf/make.log Send it and arch-linux2-c-debug/lib/petsc/conf/configure.log to petsc-maint at mcs.anl.gov ******************************************************************** Thanks, Huq On Thu, Aug 30, 2018 at 10:55 AM Jed Brown wrote: > Fazlul Huq writes: > > > I have run: > > > > jimmy at dave:~/projects/petsc$ ./configure --download-hyper > > & > > jimmy at dave:~/projects/petsc$ ./configure --download-ml > > The package name is hypre, not hyper. And you need to pass both at once > if you want both libraries to be available. > > > At the end I got following message: > > > > > xxx=========================================================================xxx > > Configure stage complete. Now build PETSc libraries with (gnumake > build): > > make PETSC_DIR=/home/jimmy/projects/petsc > PETSC_ARCH=arch-linux2-c-debug > > all > > > xxx=========================================================================xxx > > > > Am I ready to use it now or do I need no make it first? > > As the message says, you need to issue that command to build. > > > Or do I need to edit .bashrc file with, > > > > export PETSC_DIR=/home/jimmy/projects/petsc > > & > > export PETSC_ARCH=arch-linux2-c-debug all > > > > And then run make from command window? > > > > Thanks. > > Huq > > > > > > On Thu, Aug 30, 2018 at 9:40 AM Jed Brown wrote: > > > >> You would configure PETSc with --download-hypre and --download-ml (this > >> part of Trilinos can be installed on its own). Then run your > >> application with run-time options like -pc_type hypre or -pc_type ml. > >> See the user's manual and/or tutorials. > >> > >> Fazlul Huq writes: > >> > >> > Hello Petsc developers, > >> > > >> > 1. I want to integrate petsc with hyper and trilinos cause I want to > >> solve > >> > some problems using multigrid. I know, I need to download and > install > >> > both of them and then configure petsc with hyper and trilinos to use > them > >> > with petsc. But, I don't know how to configure petsc with hyper and > >> > trilinos or any other package. Is it like, running some command from > >> > terminal or editing .bashrc file? Currently, this is the .bashrc file > >> > regarding petsc in my desktop: > >> > > >> > export PETSC_DIR=/home/jimmy/projects/petsc > >> > > >> > 2. Can I use c programming routine in petsc code and make and run it? > If > >> > yes then what is the procedure? Last day I tried to do that but I got > >> error > >> > message while making the file. > >> > > >> > Thanks. > >> > > >> > -- > >> > > >> > Fazlul Huq > >> > Graduate Research Assistant > >> > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > >> > University of Illinois at Urbana-Champaign (UIUC) > >> > E-mail: huq2090 at gmail.com > >> > > > > > > -- > > > > Fazlul Huq > > Graduate Research Assistant > > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > > University of Illinois at Urbana-Champaign (UIUC) > > E-mail: huq2090 at gmail.com > -- Fazlul Huq Graduate Research Assistant Department of Nuclear, Plasma & Radiological Engineering (NPRE) University of Illinois at Urbana-Champaign (UIUC) E-mail: huq2090 at gmail.com -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Thu Aug 30 11:22:00 2018 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 30 Aug 2018 12:22:00 -0400 Subject: [petsc-users] Integration of hyper & trilinos In-Reply-To: References: <87va7ror2q.fsf@jedbrown.org> <87ftyvonm7.fsf@jedbrown.org> Message-ID: On Thu, Aug 30, 2018 at 11:59 AM Fazlul Huq wrote: > I did that and I got the following error: > > **************************ERROR************************************* > Error during compile, check arch-linux2-c-debug/lib/petsc/conf/make.log > Send it and arch-linux2-c-debug/lib/petsc/conf/configure.log to > petsc-maint at mcs.anl.gov > See the message above. It suggests a course of action. Matt > ******************************************************************** > Thanks, > Huq > > On Thu, Aug 30, 2018 at 10:55 AM Jed Brown wrote: > >> Fazlul Huq writes: >> >> > I have run: >> > >> > jimmy at dave:~/projects/petsc$ ./configure --download-hyper >> > & >> > jimmy at dave:~/projects/petsc$ ./configure --download-ml >> >> The package name is hypre, not hyper. And you need to pass both at once >> if you want both libraries to be available. >> >> > At the end I got following message: >> > >> > >> xxx=========================================================================xxx >> > Configure stage complete. Now build PETSc libraries with (gnumake >> build): >> > make PETSC_DIR=/home/jimmy/projects/petsc >> PETSC_ARCH=arch-linux2-c-debug >> > all >> > >> xxx=========================================================================xxx >> > >> > Am I ready to use it now or do I need no make it first? >> >> As the message says, you need to issue that command to build. >> >> > Or do I need to edit .bashrc file with, >> > >> > export PETSC_DIR=/home/jimmy/projects/petsc >> > & >> > export PETSC_ARCH=arch-linux2-c-debug all >> > >> > And then run make from command window? >> > >> > Thanks. >> > Huq >> > >> > >> > On Thu, Aug 30, 2018 at 9:40 AM Jed Brown wrote: >> > >> >> You would configure PETSc with --download-hypre and --download-ml (this >> >> part of Trilinos can be installed on its own). Then run your >> >> application with run-time options like -pc_type hypre or -pc_type ml. >> >> See the user's manual and/or tutorials. >> >> >> >> Fazlul Huq writes: >> >> >> >> > Hello Petsc developers, >> >> > >> >> > 1. I want to integrate petsc with hyper and trilinos cause I want to >> >> solve >> >> > some problems using multigrid. I know, I need to download and >> install >> >> > both of them and then configure petsc with hyper and trilinos to use >> them >> >> > with petsc. But, I don't know how to configure petsc with hyper and >> >> > trilinos or any other package. Is it like, running some command from >> >> > terminal or editing .bashrc file? Currently, this is the .bashrc file >> >> > regarding petsc in my desktop: >> >> > >> >> > export PETSC_DIR=/home/jimmy/projects/petsc >> >> > >> >> > 2. Can I use c programming routine in petsc code and make and run >> it? If >> >> > yes then what is the procedure? Last day I tried to do that but I got >> >> error >> >> > message while making the file. >> >> > >> >> > Thanks. >> >> > >> >> > -- >> >> > >> >> > Fazlul Huq >> >> > Graduate Research Assistant >> >> > Department of Nuclear, Plasma & Radiological Engineering (NPRE) >> >> > University of Illinois at Urbana-Champaign (UIUC) >> >> > E-mail: huq2090 at gmail.com >> >> >> > >> > >> > -- >> > >> > Fazlul Huq >> > Graduate Research Assistant >> > Department of Nuclear, Plasma & Radiological Engineering (NPRE) >> > University of Illinois at Urbana-Champaign (UIUC) >> > E-mail: huq2090 at gmail.com >> > > > -- > > Fazlul Huq > Graduate Research Assistant > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > University of Illinois at Urbana-Champaign (UIUC) > E-mail: huq2090 at gmail.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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From huq2090 at gmail.com Thu Aug 30 11:33:06 2018 From: huq2090 at gmail.com (Fazlul Huq) Date: Thu, 30 Aug 2018 11:33:06 -0500 Subject: [petsc-users] Integration of hyper & trilinos In-Reply-To: References: <87va7ror2q.fsf@jedbrown.org> <87ftyvonm7.fsf@jedbrown.org> Message-ID: I think error is in this portion, but I don't know how to fix: /home/jimmy/projects/petsc/include/petscsys.h:159:6: error: #error "PETSc was configured with one MPICH mpi.h version but now appears to be compiling using a different MPICH mpi.h version" # error "PETSc was configured with one MPICH mpi.h version but now appears to be compiling using a different MPICH mpi.h version" ^~~~~ gmakefile:150: recipe for target 'arch-linux2-c-debug/obj/sys/info/verboseinfo.o' failed make[2]: *** [arch-linux2-c-debug/obj/sys/info/verboseinfo.o] Error 1 make[2]: *** Waiting for unfinished jobs.... Use "/usr/bin/make V=1" to see verbose compile lines, "/usr/bin/make V=0" to suppress. FC arch-linux2-c-debug/obj/sys/fsrc/somefort.o FC arch-linux2-c-debug/obj/sys/f90-src/fsrc/f90_fwrap.o FC arch-linux2-c-debug/obj/sys/f90-mod/petscsysmod.o make[2]: Leaving directory '/home/jimmy/projects/petsc' /home/jimmy/projects/petsc/lib/petsc/conf/rules:81: recipe for target 'gnumake' failed make[1]: *** [gnumake] Error 2 make[1]: Leaving directory '/home/jimmy/projects/petsc' **************************ERROR************************************* Error during compile, check arch-linux2-c-debug/lib/petsc/conf/make.log Send it and arch-linux2-c-debug/lib/petsc/conf/configure.log to petsc-maint at mcs.anl.gov ******************************************************************** makefile:30: recipe for target 'all' failed make: *** [all] Error 1 Thanks. Huq On Thu, Aug 30, 2018 at 11:22 AM Matthew Knepley wrote: > On Thu, Aug 30, 2018 at 11:59 AM Fazlul Huq wrote: > >> I did that and I got the following error: >> >> **************************ERROR************************************* >> Error during compile, check arch-linux2-c-debug/lib/petsc/conf/make.log >> Send it and arch-linux2-c-debug/lib/petsc/conf/configure.log to >> petsc-maint at mcs.anl.gov >> > > See the message above. It suggests a course of action. > > Matt > > >> ******************************************************************** >> Thanks, >> Huq >> >> On Thu, Aug 30, 2018 at 10:55 AM Jed Brown wrote: >> >>> Fazlul Huq writes: >>> >>> > I have run: >>> > >>> > jimmy at dave:~/projects/petsc$ ./configure --download-hyper >>> > & >>> > jimmy at dave:~/projects/petsc$ ./configure --download-ml >>> >>> The package name is hypre, not hyper. And you need to pass both at once >>> if you want both libraries to be available. >>> >>> > At the end I got following message: >>> > >>> > >>> xxx=========================================================================xxx >>> > Configure stage complete. Now build PETSc libraries with (gnumake >>> build): >>> > make PETSC_DIR=/home/jimmy/projects/petsc >>> PETSC_ARCH=arch-linux2-c-debug >>> > all >>> > >>> xxx=========================================================================xxx >>> > >>> > Am I ready to use it now or do I need no make it first? >>> >>> As the message says, you need to issue that command to build. >>> >>> > Or do I need to edit .bashrc file with, >>> > >>> > export PETSC_DIR=/home/jimmy/projects/petsc >>> > & >>> > export PETSC_ARCH=arch-linux2-c-debug all >>> > >>> > And then run make from command window? >>> > >>> > Thanks. >>> > Huq >>> > >>> > >>> > On Thu, Aug 30, 2018 at 9:40 AM Jed Brown wrote: >>> > >>> >> You would configure PETSc with --download-hypre and --download-ml >>> (this >>> >> part of Trilinos can be installed on its own). Then run your >>> >> application with run-time options like -pc_type hypre or -pc_type ml. >>> >> See the user's manual and/or tutorials. >>> >> >>> >> Fazlul Huq writes: >>> >> >>> >> > Hello Petsc developers, >>> >> > >>> >> > 1. I want to integrate petsc with hyper and trilinos cause I want to >>> >> solve >>> >> > some problems using multigrid. I know, I need to download and >>> install >>> >> > both of them and then configure petsc with hyper and trilinos to >>> use them >>> >> > with petsc. But, I don't know how to configure petsc with hyper and >>> >> > trilinos or any other package. Is it like, running some command from >>> >> > terminal or editing .bashrc file? Currently, this is the .bashrc >>> file >>> >> > regarding petsc in my desktop: >>> >> > >>> >> > export PETSC_DIR=/home/jimmy/projects/petsc >>> >> > >>> >> > 2. Can I use c programming routine in petsc code and make and run >>> it? If >>> >> > yes then what is the procedure? Last day I tried to do that but I >>> got >>> >> error >>> >> > message while making the file. >>> >> > >>> >> > Thanks. >>> >> > >>> >> > -- >>> >> > >>> >> > Fazlul Huq >>> >> > Graduate Research Assistant >>> >> > Department of Nuclear, Plasma & Radiological Engineering (NPRE) >>> >> > University of Illinois at Urbana-Champaign (UIUC) >>> >> > E-mail: huq2090 at gmail.com >>> >> >>> > >>> > >>> > -- >>> > >>> > Fazlul Huq >>> > Graduate Research Assistant >>> > Department of Nuclear, Plasma & Radiological Engineering (NPRE) >>> > University of Illinois at Urbana-Champaign (UIUC) >>> > E-mail: huq2090 at gmail.com >>> >> >> >> -- >> >> Fazlul Huq >> Graduate Research Assistant >> Department of Nuclear, Plasma & Radiological Engineering (NPRE) >> University of Illinois at Urbana-Champaign (UIUC) >> E-mail: huq2090 at gmail.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 > > https://www.cse.buffalo.edu/~knepley/ > > -- Fazlul Huq Graduate Research Assistant Department of Nuclear, Plasma & Radiological Engineering (NPRE) University of Illinois at Urbana-Champaign (UIUC) E-mail: huq2090 at gmail.com -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 30 12:27:22 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 30 Aug 2018 17:27:22 +0000 Subject: [petsc-users] Questions about x-window and matlab engine in PETSc In-Reply-To: References: Message-ID: <03066727-89AB-4B13-AF80-B9F19FA05D45@anl.gov> > On Aug 30, 2018, at 3:09 AM, Yingjie Wu wrote: > > Dear PETSc developer, > Hi, > Thank you very much for helping me solve the problem before. Recently, I reinstalled my system and reinstalled PETSc and found the following problems: > > 1. when I ran the example src/vec/vec/example/tutorial/ex3, there was a error: > [0] PETSC ERROR: PETSc installed without X windows, Microsoft Graphics, OpenGL ES, or GLUT / OpenGL on this machine > I installed PETSc following the official website. I don't know how to solve this error. > 2. I want to use matlab to do input and output data. My data is mainly the information of model parameters and initial values in each grid, which is usually stored in the form of matrix or vector. In src / vec / vec / example / tutorial / ex5, the input and output data in the binary file. dat, but I don't know how to open it for subsequent analysis. I want to input or output data to PETSc in the form of matrix and vector in MATLAB. I don't know how to use MATLAB as the input and output interface. It would be better if there were examples. > 3. Is there a web page that can query the usage of PETSc function? For example, Http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Viewer/PetscViewerBinaryOpen.html > For beginners like me, a web page that queries how functions are used is very useful. At the bottom of most manual pages is a list of examples that use the given function. If you find some manual pages without example links please let us know. > > Thanks, > Yingjie From bsmith at mcs.anl.gov Thu Aug 30 12:29:38 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 30 Aug 2018 17:29:38 +0000 Subject: [petsc-users] Problem with SNES convergence In-Reply-To: References: <1371398831.496454.1535553418412.ref@mail.yahoo.com> <1371398831.496454.1535553418412@mail.yahoo.com> <387994F6-79FF-4DE4-8375-B24F63B0F332@anl.gov> <1135178798.714456.1535603850997@mail.yahoo.com> Message-ID: Note also that the PETSc TS component has a large variety of timesteppers with automatic adaptivity which adjust the time-step for accuracy and convergence. Depending on the exact needs of your time-stepper it might be easier in the long run to use PETSc's time-steppers rather than write your own. Barry > On Aug 30, 2018, at 10:46 AM, Ling Zou wrote: > > Rahul, please see the logic I used to reduce time step size. > Hope this helps you. > > Ling > > for (timestep = 1; timestep <= N; timestep++) // loop over time steps > { > // before trying to solve a time step, 1) it is still not successful; 2) we are not giving up; 3) haven't failed yet > bool give_up = false; bool success = false; bool experienced_fail_this_time_step = false; > // save solutions and old solutions into u_copy and u_old_copy, in case a time step fails and we restart from this saved solutions > VecCopy(u, u_copy); VecCopy(u_old, u_old_copy); > > while ((!give_up) && (!success)) // as long as not successful and not giving up, we solve again with smaller time step > { > if (time_step_size < dt_min) { give_up = true; break; } // ok, bad luck, give up due to time step size smaller than a preset value > if (experienced_fail_this_time_step) { // get the vectors from backups if this is a re-try, i.e., already failed with a larger time step > VecCopy(u_old_copy, u); VecCopy(u_old_copy, u_old); > } > > try { > SNESSolve(snes, NULL, u); > SNESGetConvergedReason(snes, &snes_converged_reason); > > if (snes_converged_reason > 0) success = true; // yes, snes converged > else { // no, snes did not converge > cutTimeStepSize(); // e.g., dt / 2 > experienced_fail_this_time_step = true; > } > } > catch (int err) { // in case your own pieces of code throws an exception > std::cout << "An exception occurred." << std::endl; > success = false; > cutTimeStepSize(); // e.g., dt / 2 > experienced_fail_this_time_step = true; > } > } > > if (success) { > // output, print, whatever > // duplicate current solution to old solution in preparing next time step > VecCopy(u, u_old); > // you can increase time step size here, e.g. * 2 > increaseTimeStepSize(); > } > > if (give_up) { > simulationFailed = true; > std::cerr << "Simulation failed.\n"; > //exit(1);// dont exit(1) now, just break the for-loop, let PETSc clean its workspace. > break; > } > } > > From: Rahul Samala > Sent: Wednesday, August 29, 2018 10:37:30 PM > To: Ling Zou; Smith, Barry F. > Cc: PETSc Users List > Subject: Re: [petsc-users] Problem with SNES convergence > > Thank you Ling, I would definitely like to look at your code for reducing timestep size. > Thank you Barry for your inputs. > > -- > Rahul. > > On Wednesday, August 29, 2018, 9:02:00 PM GMT+5:30, Smith, Barry F. wrote: > > > > Current time (before start of timestep) 52.5048, iter=5380 Timestep=864.000000 > 0 SNES Function norm 1.650467412595e+05 > 0 KSP preconditioned resid norm 3.979123221160e+03 true resid norm 1.650467412595e+05 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 9.178246525982e-11 true resid norm 7.006473307032e-09 ||r(i)||/||b|| 4.245144892632e-14 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 1 SNES Function norm 6.722712947273e+02 > Linear solve did not converge due to DIVERGED_NANORINF iterations 0 > Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 1 > > This usually is an indicator that the LU (ILU) factorization has hit a zero pivot (hence the linear solve has a divide by zero so gives the DIVERGED_NANORINF flag). > > You can/should call SNESGetConvergedReason() immediately after each SNESSolve(), if the result is negative that means something has failed in the nonlinear solve and you can try cutting the time-step and trying again. > > Good luck, > > Barry > > > > On Aug 29, 2018, at 10:11 AM, Ling Zou wrote: > > > > 1) My experience is that this kind of bug or sudden death (everything is fine till suddenly something is broken) is very difficult to debug/fix. I looked at your txt files and could not give any quick comments. Maybe PETSc developers have better idea on this. > > 2) I do have successful experience on reducing time step size when PETSc fails solving or my own piece of code throws an exception. If you are interested, I can share them. > > > > -Ling > > From: petsc-users on behalf of Rahul Samala > > Sent: Wednesday, August 29, 2018 8:36:58 AM > > To: PETSc Users List > > Subject: [petsc-users] Problem with SNES convergence > > > > Hello PetSc users, > > > > 1) I have problem with SNES convergence. I call SNESSolve in a time loop and use the inbuilt Jacobian feature. The code works fine for about 5380 time steps after which it breaks down. The solution till that point looks fine. I have used newtonls of type l2. (newtontr and others aren't working). Since I have used inbuilt Jacobian feature and the code worked for about 5000 time steps I don't understand the reason for failure, is it an incorrect function evaluation? Attached are the outputs with -pc_type lu and ilu along with -snes_linesearch_type l2 -snes_converged_reason -snes_monitor -snes_view -ksp_converged_reason -ksp_monitor_true_residual > > > > 2) How to get hold of failure signal, like Nonlinear solve DIVERGED_MAX_IT or DIVERGED_LINEAR_SOLVE so that whenever it occurs I can use a reduced time step and see if the code converges. > > > > Thank you, > > Rahul. > > > > output_ilu.txt > > > > > > output_ilu.txt > > > > > > > > output_lu.txt > > > > > > output_lu.txt From bsmith at mcs.anl.gov Thu Aug 30 12:33:42 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 30 Aug 2018 17:33:42 +0000 Subject: [petsc-users] Integration of hyper & trilinos In-Reply-To: References: <87va7ror2q.fsf@jedbrown.org> <87ftyvonm7.fsf@jedbrown.org> Message-ID: Please read and follow the directions that PETSc prints out, this will reduced unneeded emails back and forth. The instructions were to send the files configure.log and make.log to petsc-maint at mcs.anl.gov and we'll see if we can resolve the MPI issue. Barry > On Aug 30, 2018, at 11:33 AM, Fazlul Huq wrote: > > I think error is in this portion, but I don't know how to fix: > > /home/jimmy/projects/petsc/include/petscsys.h:159:6: error: #error "PETSc was configured with one MPICH mpi.h version but now appears to be compiling using a different MPICH mpi.h version" > # error "PETSc was configured with one MPICH mpi.h version but now appears to be compiling using a different MPICH mpi.h version" > ^~~~~ > gmakefile:150: recipe for target 'arch-linux2-c-debug/obj/sys/info/verboseinfo.o' failed > make[2]: *** [arch-linux2-c-debug/obj/sys/info/verboseinfo.o] Error 1 > make[2]: *** Waiting for unfinished jobs.... > Use "/usr/bin/make V=1" to see verbose compile lines, "/usr/bin/make V=0" to suppress. > FC arch-linux2-c-debug/obj/sys/fsrc/somefort.o > FC arch-linux2-c-debug/obj/sys/f90-src/fsrc/f90_fwrap.o > FC arch-linux2-c-debug/obj/sys/f90-mod/petscsysmod.o > make[2]: Leaving directory '/home/jimmy/projects/petsc' > /home/jimmy/projects/petsc/lib/petsc/conf/rules:81: recipe for target 'gnumake' failed > make[1]: *** [gnumake] Error 2 > make[1]: Leaving directory '/home/jimmy/projects/petsc' > **************************ERROR************************************* > Error during compile, check arch-linux2-c-debug/lib/petsc/conf/make.log > Send it and arch-linux2-c-debug/lib/petsc/conf/configure.log to petsc-maint at mcs.anl.gov > ******************************************************************** > makefile:30: recipe for target 'all' failed > make: *** [all] Error 1 > > Thanks. > Huq > > On Thu, Aug 30, 2018 at 11:22 AM Matthew Knepley wrote: > On Thu, Aug 30, 2018 at 11:59 AM Fazlul Huq wrote: > I did that and I got the following error: > > **************************ERROR************************************* > Error during compile, check arch-linux2-c-debug/lib/petsc/conf/make.log > Send it and arch-linux2-c-debug/lib/petsc/conf/configure.log to petsc-maint at mcs.anl.gov > > See the message above. It suggests a course of action. > > Matt > > ******************************************************************** > Thanks, > Huq > > On Thu, Aug 30, 2018 at 10:55 AM Jed Brown wrote: > Fazlul Huq writes: > > > I have run: > > > > jimmy at dave:~/projects/petsc$ ./configure --download-hyper > > & > > jimmy at dave:~/projects/petsc$ ./configure --download-ml > > The package name is hypre, not hyper. And you need to pass both at once > if you want both libraries to be available. > > > At the end I got following message: > > > > xxx=========================================================================xxx > > Configure stage complete. Now build PETSc libraries with (gnumake build): > > make PETSC_DIR=/home/jimmy/projects/petsc PETSC_ARCH=arch-linux2-c-debug > > all > > xxx=========================================================================xxx > > > > Am I ready to use it now or do I need no make it first? > > As the message says, you need to issue that command to build. > > > Or do I need to edit .bashrc file with, > > > > export PETSC_DIR=/home/jimmy/projects/petsc > > & > > export PETSC_ARCH=arch-linux2-c-debug all > > > > And then run make from command window? > > > > Thanks. > > Huq > > > > > > On Thu, Aug 30, 2018 at 9:40 AM Jed Brown wrote: > > > >> You would configure PETSc with --download-hypre and --download-ml (this > >> part of Trilinos can be installed on its own). Then run your > >> application with run-time options like -pc_type hypre or -pc_type ml. > >> See the user's manual and/or tutorials. > >> > >> Fazlul Huq writes: > >> > >> > Hello Petsc developers, > >> > > >> > 1. I want to integrate petsc with hyper and trilinos cause I want to > >> solve > >> > some problems using multigrid. I know, I need to download and install > >> > both of them and then configure petsc with hyper and trilinos to use them > >> > with petsc. But, I don't know how to configure petsc with hyper and > >> > trilinos or any other package. Is it like, running some command from > >> > terminal or editing .bashrc file? Currently, this is the .bashrc file > >> > regarding petsc in my desktop: > >> > > >> > export PETSC_DIR=/home/jimmy/projects/petsc > >> > > >> > 2. Can I use c programming routine in petsc code and make and run it? If > >> > yes then what is the procedure? Last day I tried to do that but I got > >> error > >> > message while making the file. > >> > > >> > Thanks. > >> > > >> > -- > >> > > >> > Fazlul Huq > >> > Graduate Research Assistant > >> > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > >> > University of Illinois at Urbana-Champaign (UIUC) > >> > E-mail: huq2090 at gmail.com > >> > > > > > > -- > > > > Fazlul Huq > > Graduate Research Assistant > > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > > University of Illinois at Urbana-Champaign (UIUC) > > E-mail: huq2090 at gmail.com > > > -- > > Fazlul Huq > Graduate Research Assistant > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > University of Illinois at Urbana-Champaign (UIUC) > E-mail: huq2090 at gmail.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 > > https://www.cse.buffalo.edu/~knepley/ > > > -- > > Fazlul Huq > Graduate Research Assistant > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > University of Illinois at Urbana-Champaign (UIUC) > E-mail: huq2090 at gmail.com From fdkong.jd at gmail.com Thu Aug 30 12:49:24 2018 From: fdkong.jd at gmail.com (Fande Kong) Date: Thu, 30 Aug 2018 11:49:24 -0600 Subject: [petsc-users] Problem with SNES convergence In-Reply-To: References: <1371398831.496454.1535553418412.ref@mail.yahoo.com> <1371398831.496454.1535553418412@mail.yahoo.com> <387994F6-79FF-4DE4-8375-B24F63B0F332@anl.gov> <1135178798.714456.1535603850997@mail.yahoo.com> Message-ID: Hi Barry, I haven't had time to look into TS so far. But it is definitely interesting. One simple question would like this: If I have a simple loop for time steppers, and each step SNES is called. How hard to convert my code to use TS? Any suggestion? Where should I start from? Fande, On Thu, Aug 30, 2018 at 11:29 AM Smith, Barry F. wrote: > > Note also that the PETSc TS component has a large variety of > timesteppers with automatic adaptivity which adjust the time-step for > accuracy and convergence. Depending on the exact needs of your time-stepper > it might be easier in the long run to use PETSc's time-steppers rather than > write your own. > > Barry > > > > On Aug 30, 2018, at 10:46 AM, Ling Zou wrote: > > > > Rahul, please see the logic I used to reduce time step size. > > Hope this helps you. > > > > Ling > > > > for (timestep = 1; timestep <= N; timestep++) // loop over time steps > > { > > // before trying to solve a time step, 1) it is still not successful; > 2) we are not giving up; 3) haven't failed yet > > bool give_up = false; bool success = false; bool > experienced_fail_this_time_step = false; > > // save solutions and old solutions into u_copy and u_old_copy, in > case a time step fails and we restart from this saved solutions > > VecCopy(u, u_copy); VecCopy(u_old, u_old_copy); > > > > while ((!give_up) && (!success)) // as long as not successful and not > giving up, we solve again with smaller time step > > { > > if (time_step_size < dt_min) { give_up = true; break; } // ok, bad > luck, give up due to time step size smaller than a preset value > > if (experienced_fail_this_time_step) { // get the vectors from > backups if this is a re-try, i.e., already failed with a larger time step > > VecCopy(u_old_copy, u); VecCopy(u_old_copy, u_old); > > } > > > > try { > > SNESSolve(snes, NULL, u); > > SNESGetConvergedReason(snes, &snes_converged_reason); > > > > if (snes_converged_reason > 0) success = true; // yes, snes > converged > > else { // no, snes did not converge > > cutTimeStepSize(); // e.g., dt / 2 > > experienced_fail_this_time_step = true; > > } > > } > > catch (int err) { // in case your own pieces of code throws an > exception > > std::cout << "An exception occurred." << std::endl; > > success = false; > > cutTimeStepSize(); // e.g., dt / 2 > > experienced_fail_this_time_step = true; > > } > > } > > > > if (success) { > > // output, print, whatever > > // duplicate current solution to old solution in preparing next time > step > > VecCopy(u, u_old); > > // you can increase time step size here, e.g. * 2 > > increaseTimeStepSize(); > > } > > > > if (give_up) { > > simulationFailed = true; > > std::cerr << "Simulation failed.\n"; > > //exit(1);// dont exit(1) now, just break the for-loop, let PETSc > clean its workspace. > > break; > > } > > } > > > > From: Rahul Samala > > Sent: Wednesday, August 29, 2018 10:37:30 PM > > To: Ling Zou; Smith, Barry F. > > Cc: PETSc Users List > > Subject: Re: [petsc-users] Problem with SNES convergence > > > > Thank you Ling, I would definitely like to look at your code for > reducing timestep size. > > Thank you Barry for your inputs. > > > > -- > > Rahul. > > > > On Wednesday, August 29, 2018, 9:02:00 PM GMT+5:30, Smith, Barry F. < > bsmith at mcs.anl.gov> wrote: > > > > > > > > Current time (before start of timestep) 52.5048, iter=5380 > Timestep=864.000000 > > 0 SNES Function norm 1.650467412595e+05 > > 0 KSP preconditioned resid norm 3.979123221160e+03 true resid norm > 1.650467412595e+05 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 9.178246525982e-11 true resid norm > 7.006473307032e-09 ||r(i)||/||b|| 4.245144892632e-14 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 1 SNES Function norm 6.722712947273e+02 > > Linear solve did not converge due to DIVERGED_NANORINF iterations 0 > > Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations > 1 > > > > This usually is an indicator that the LU (ILU) factorization has hit > a zero pivot (hence the linear solve has a divide by zero so gives the > DIVERGED_NANORINF flag). > > > > You can/should call SNESGetConvergedReason() immediately after each > SNESSolve(), if the result is negative that means something has failed in > the nonlinear solve and you can try cutting the time-step and trying again. > > > > Good luck, > > > > Barry > > > > > > > On Aug 29, 2018, at 10:11 AM, Ling Zou wrote: > > > > > > 1) My experience is that this kind of bug or sudden death (everything > is fine till suddenly something is broken) is very difficult to debug/fix. > I looked at your txt files and could not give any quick comments. Maybe > PETSc developers have better idea on this. > > > 2) I do have successful experience on reducing time step size when > PETSc fails solving or my own piece of code throws an exception. If you are > interested, I can share them. > > > > > > -Ling > > > From: petsc-users on behalf of > Rahul Samala > > > Sent: Wednesday, August 29, 2018 8:36:58 AM > > > To: PETSc Users List > > > Subject: [petsc-users] Problem with SNES convergence > > > > > > Hello PetSc users, > > > > > > 1) I have problem with SNES convergence. I call SNESSolve in a time > loop and use the inbuilt Jacobian feature. The code works fine for about > 5380 time steps after which it breaks down. The solution till that point > looks fine. I have used newtonls of type l2. (newtontr and others aren't > working). Since I have used inbuilt Jacobian feature and the code worked > for about 5000 time steps I don't understand the reason for failure, is it > an incorrect function evaluation? Attached are the outputs with -pc_type > lu and ilu along with -snes_linesearch_type l2 -snes_converged_reason > -snes_monitor -snes_view -ksp_converged_reason -ksp_monitor_true_residual > > > > > > 2) How to get hold of failure signal, like Nonlinear solve > DIVERGED_MAX_IT or DIVERGED_LINEAR_SOLVE so that whenever it occurs I can > use a reduced time step and see if the code converges. > > > > > > Thank you, > > > Rahul. > > > > > > output_ilu.txt > > > > > > > > > output_ilu.txt > > > > > > > > > > > > output_lu.txt > > > > > > > > > output_lu.txt > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 30 12:55:30 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Thu, 30 Aug 2018 17:55:30 +0000 Subject: [petsc-users] Problem with SNES convergence In-Reply-To: References: <1371398831.496454.1535553418412.ref@mail.yahoo.com> <1371398831.496454.1535553418412@mail.yahoo.com> <387994F6-79FF-4DE4-8375-B24F63B0F332@anl.gov> <1135178798.714456.1535603850997@mail.yahoo.com> Message-ID: <7337A99E-C3BE-48EF-BC95-4A1736227F8E@mcs.anl.gov> > On Aug 30, 2018, at 12:49 PM, Fande Kong wrote: > > Hi Barry, > > I haven't had time to look into TS so far. But it is definitely interesting. One simple question would like this: If I have a simple loop for time steppers, and each step SNES is called. How hard to convert my code to use TS? You would need to look at the examples in ts/examples/tutorials but essentially you need to provide a slightly different version of FormFunction() and FormJacobian() and call TSSolve() etc instead of having your own loop. Barry > > Any suggestion? Where should I start from? > > > Fande, > > On Thu, Aug 30, 2018 at 11:29 AM Smith, Barry F. wrote: > > Note also that the PETSc TS component has a large variety of timesteppers with automatic adaptivity which adjust the time-step for accuracy and convergence. Depending on the exact needs of your time-stepper it might be easier in the long run to use PETSc's time-steppers rather than write your own. > > Barry > > > > On Aug 30, 2018, at 10:46 AM, Ling Zou wrote: > > > > Rahul, please see the logic I used to reduce time step size. > > Hope this helps you. > > > > Ling > > > > for (timestep = 1; timestep <= N; timestep++) // loop over time steps > > { > > // before trying to solve a time step, 1) it is still not successful; 2) we are not giving up; 3) haven't failed yet > > bool give_up = false; bool success = false; bool experienced_fail_this_time_step = false; > > // save solutions and old solutions into u_copy and u_old_copy, in case a time step fails and we restart from this saved solutions > > VecCopy(u, u_copy); VecCopy(u_old, u_old_copy); > > > > while ((!give_up) && (!success)) // as long as not successful and not giving up, we solve again with smaller time step > > { > > if (time_step_size < dt_min) { give_up = true; break; } // ok, bad luck, give up due to time step size smaller than a preset value > > if (experienced_fail_this_time_step) { // get the vectors from backups if this is a re-try, i.e., already failed with a larger time step > > VecCopy(u_old_copy, u); VecCopy(u_old_copy, u_old); > > } > > > > try { > > SNESSolve(snes, NULL, u); > > SNESGetConvergedReason(snes, &snes_converged_reason); > > > > if (snes_converged_reason > 0) success = true; // yes, snes converged > > else { // no, snes did not converge > > cutTimeStepSize(); // e.g., dt / 2 > > experienced_fail_this_time_step = true; > > } > > } > > catch (int err) { // in case your own pieces of code throws an exception > > std::cout << "An exception occurred." << std::endl; > > success = false; > > cutTimeStepSize(); // e.g., dt / 2 > > experienced_fail_this_time_step = true; > > } > > } > > > > if (success) { > > // output, print, whatever > > // duplicate current solution to old solution in preparing next time step > > VecCopy(u, u_old); > > // you can increase time step size here, e.g. * 2 > > increaseTimeStepSize(); > > } > > > > if (give_up) { > > simulationFailed = true; > > std::cerr << "Simulation failed.\n"; > > //exit(1);// dont exit(1) now, just break the for-loop, let PETSc clean its workspace. > > break; > > } > > } > > > > From: Rahul Samala > > Sent: Wednesday, August 29, 2018 10:37:30 PM > > To: Ling Zou; Smith, Barry F. > > Cc: PETSc Users List > > Subject: Re: [petsc-users] Problem with SNES convergence > > > > Thank you Ling, I would definitely like to look at your code for reducing timestep size. > > Thank you Barry for your inputs. > > > > -- > > Rahul. > > > > On Wednesday, August 29, 2018, 9:02:00 PM GMT+5:30, Smith, Barry F. wrote: > > > > > > > > Current time (before start of timestep) 52.5048, iter=5380 Timestep=864.000000 > > 0 SNES Function norm 1.650467412595e+05 > > 0 KSP preconditioned resid norm 3.979123221160e+03 true resid norm 1.650467412595e+05 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 9.178246525982e-11 true resid norm 7.006473307032e-09 ||r(i)||/||b|| 4.245144892632e-14 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 1 SNES Function norm 6.722712947273e+02 > > Linear solve did not converge due to DIVERGED_NANORINF iterations 0 > > Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 1 > > > > This usually is an indicator that the LU (ILU) factorization has hit a zero pivot (hence the linear solve has a divide by zero so gives the DIVERGED_NANORINF flag). > > > > You can/should call SNESGetConvergedReason() immediately after each SNESSolve(), if the result is negative that means something has failed in the nonlinear solve and you can try cutting the time-step and trying again. > > > > Good luck, > > > > Barry > > > > > > > On Aug 29, 2018, at 10:11 AM, Ling Zou wrote: > > > > > > 1) My experience is that this kind of bug or sudden death (everything is fine till suddenly something is broken) is very difficult to debug/fix. I looked at your txt files and could not give any quick comments. Maybe PETSc developers have better idea on this. > > > 2) I do have successful experience on reducing time step size when PETSc fails solving or my own piece of code throws an exception. If you are interested, I can share them. > > > > > > -Ling > > > From: petsc-users on behalf of Rahul Samala > > > Sent: Wednesday, August 29, 2018 8:36:58 AM > > > To: PETSc Users List > > > Subject: [petsc-users] Problem with SNES convergence > > > > > > Hello PetSc users, > > > > > > 1) I have problem with SNES convergence. I call SNESSolve in a time loop and use the inbuilt Jacobian feature. The code works fine for about 5380 time steps after which it breaks down. The solution till that point looks fine. I have used newtonls of type l2. (newtontr and others aren't working). Since I have used inbuilt Jacobian feature and the code worked for about 5000 time steps I don't understand the reason for failure, is it an incorrect function evaluation? Attached are the outputs with -pc_type lu and ilu along with -snes_linesearch_type l2 -snes_converged_reason -snes_monitor -snes_view -ksp_converged_reason -ksp_monitor_true_residual > > > > > > 2) How to get hold of failure signal, like Nonlinear solve DIVERGED_MAX_IT or DIVERGED_LINEAR_SOLVE so that whenever it occurs I can use a reduced time step and see if the code converges. > > > > > > Thank you, > > > Rahul. > > > > > > output_ilu.txt > > > > > > > > > output_ilu.txt > > > > > > > > > > > > output_lu.txt > > > > > > > > > output_lu.txt > From huq2090 at gmail.com Thu Aug 30 13:17:46 2018 From: huq2090 at gmail.com (Fazlul Huq) Date: Thu, 30 Aug 2018 13:17:46 -0500 Subject: [petsc-users] Integration of hyper & trilinos In-Reply-To: References: <87va7ror2q.fsf@jedbrown.org> <87ftyvonm7.fsf@jedbrown.org> Message-ID: Sorry for not getting it! Thanks! Have send it to petsc-maint at mcs.anl.gov Sincerely, Huq On Thu, Aug 30, 2018 at 12:33 PM Smith, Barry F. wrote: > > Please read and follow the directions that PETSc prints out, this will > reduced unneeded emails back and forth. The instructions were to send the > files > > configure.log and make.log > > to petsc-maint at mcs.anl.gov and we'll see if we can resolve the MPI issue. > > Barry > > > > On Aug 30, 2018, at 11:33 AM, Fazlul Huq wrote: > > > > I think error is in this portion, but I don't know how to fix: > > > > /home/jimmy/projects/petsc/include/petscsys.h:159:6: error: #error > "PETSc was configured with one MPICH mpi.h version but now appears to be > compiling using a different MPICH mpi.h version" > > # error "PETSc was configured with one MPICH mpi.h version but now > appears to be compiling using a different MPICH mpi.h version" > > ^~~~~ > > gmakefile:150: recipe for target > 'arch-linux2-c-debug/obj/sys/info/verboseinfo.o' failed > > make[2]: *** [arch-linux2-c-debug/obj/sys/info/verboseinfo.o] Error 1 > > make[2]: *** Waiting for unfinished jobs.... > > Use "/usr/bin/make V=1" to see verbose compile lines, "/usr/bin/make > V=0" to suppress. > > FC arch-linux2-c-debug/obj/sys/fsrc/somefort.o > > FC arch-linux2-c-debug/obj/sys/f90-src/fsrc/f90_fwrap.o > > FC arch-linux2-c-debug/obj/sys/f90-mod/petscsysmod.o > > make[2]: Leaving directory '/home/jimmy/projects/petsc' > > /home/jimmy/projects/petsc/lib/petsc/conf/rules:81: recipe for target > 'gnumake' failed > > make[1]: *** [gnumake] Error 2 > > make[1]: Leaving directory '/home/jimmy/projects/petsc' > > **************************ERROR************************************* > > Error during compile, check arch-linux2-c-debug/lib/petsc/conf/make.log > > Send it and arch-linux2-c-debug/lib/petsc/conf/configure.log to > petsc-maint at mcs.anl.gov > > ******************************************************************** > > makefile:30: recipe for target 'all' failed > > make: *** [all] Error 1 > > > > Thanks. > > Huq > > > > On Thu, Aug 30, 2018 at 11:22 AM Matthew Knepley > wrote: > > On Thu, Aug 30, 2018 at 11:59 AM Fazlul Huq wrote: > > I did that and I got the following error: > > > > **************************ERROR************************************* > > Error during compile, check arch-linux2-c-debug/lib/petsc/conf/make.log > > Send it and arch-linux2-c-debug/lib/petsc/conf/configure.log to > petsc-maint at mcs.anl.gov > > > > See the message above. It suggests a course of action. > > > > Matt > > > > ******************************************************************** > > Thanks, > > Huq > > > > On Thu, Aug 30, 2018 at 10:55 AM Jed Brown wrote: > > Fazlul Huq writes: > > > > > I have run: > > > > > > jimmy at dave:~/projects/petsc$ ./configure --download-hyper > > > & > > > jimmy at dave:~/projects/petsc$ ./configure --download-ml > > > > The package name is hypre, not hyper. And you need to pass both at once > > if you want both libraries to be available. > > > > > At the end I got following message: > > > > > > > xxx=========================================================================xxx > > > Configure stage complete. Now build PETSc libraries with (gnumake > build): > > > make PETSC_DIR=/home/jimmy/projects/petsc > PETSC_ARCH=arch-linux2-c-debug > > > all > > > > xxx=========================================================================xxx > > > > > > Am I ready to use it now or do I need no make it first? > > > > As the message says, you need to issue that command to build. > > > > > Or do I need to edit .bashrc file with, > > > > > > export PETSC_DIR=/home/jimmy/projects/petsc > > > & > > > export PETSC_ARCH=arch-linux2-c-debug all > > > > > > And then run make from command window? > > > > > > Thanks. > > > Huq > > > > > > > > > On Thu, Aug 30, 2018 at 9:40 AM Jed Brown wrote: > > > > > >> You would configure PETSc with --download-hypre and --download-ml > (this > > >> part of Trilinos can be installed on its own). Then run your > > >> application with run-time options like -pc_type hypre or -pc_type ml. > > >> See the user's manual and/or tutorials. > > >> > > >> Fazlul Huq writes: > > >> > > >> > Hello Petsc developers, > > >> > > > >> > 1. I want to integrate petsc with hyper and trilinos cause I want to > > >> solve > > >> > some problems using multigrid. I know, I need to download and > install > > >> > both of them and then configure petsc with hyper and trilinos to > use them > > >> > with petsc. But, I don't know how to configure petsc with hyper and > > >> > trilinos or any other package. Is it like, running some command from > > >> > terminal or editing .bashrc file? Currently, this is the .bashrc > file > > >> > regarding petsc in my desktop: > > >> > > > >> > export PETSC_DIR=/home/jimmy/projects/petsc > > >> > > > >> > 2. Can I use c programming routine in petsc code and make and run > it? If > > >> > yes then what is the procedure? Last day I tried to do that but I > got > > >> error > > >> > message while making the file. > > >> > > > >> > Thanks. > > >> > > > >> > -- > > >> > > > >> > Fazlul Huq > > >> > Graduate Research Assistant > > >> > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > > >> > University of Illinois at Urbana-Champaign (UIUC) > > >> > E-mail: huq2090 at gmail.com > > >> > > > > > > > > > -- > > > > > > Fazlul Huq > > > Graduate Research Assistant > > > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > > > University of Illinois at Urbana-Champaign (UIUC) > > > E-mail: huq2090 at gmail.com > > > > > > -- > > > > Fazlul Huq > > Graduate Research Assistant > > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > > University of Illinois at Urbana-Champaign (UIUC) > > E-mail: huq2090 at gmail.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 > > > > https://www.cse.buffalo.edu/~knepley/ > > > > > > -- > > > > Fazlul Huq > > Graduate Research Assistant > > Department of Nuclear, Plasma & Radiological Engineering (NPRE) > > University of Illinois at Urbana-Champaign (UIUC) > > E-mail: huq2090 at gmail.com > > -- Fazlul Huq Graduate Research Assistant Department of Nuclear, Plasma & Radiological Engineering (NPRE) University of Illinois at Urbana-Champaign (UIUC) E-mail: huq2090 at gmail.com -------------- next part -------------- An HTML attachment was scrubbed... URL: From mvalera-w at sdsu.edu Thu Aug 30 15:41:13 2018 From: mvalera-w at sdsu.edu (Manuel Valera) Date: Thu, 30 Aug 2018 13:41:13 -0700 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: Matthew, and anyone who wants to chip in on this, Just to close this thread then, can you suggest a roadmap to get this MPI+GPU hibrydization done? you mentioned the ASM PCs, i may look into that, but is not clear to me now if this is doable now in PETSc or if i have to wait for more functionality to be added, I have two available machines, one with 20 cores and a P100 GPU, and other with 8 V100 GPUs and MPI for communication, how would you guys do this? My model is fully distributed with DMDAs except for output, and the linear solver takes around 56% of the computation time, Thanks, On Thu, Aug 30, 2018 at 8:25 AM, Matthew Knepley wrote: > On Thu, Aug 30, 2018 at 10:52 AM Manuel Valera wrote: > >> I thought newer NVIDIA cards had integrated circuits, not using PCI >> anymore, still the same case? >> >> How would the GPU clusters work, then? Let's say i have a cluster of GPUs >> communicated by an MPI node, would PETSc work on this configuration at some >> point? This would be my next step if I could make the MPI matrices work >> with GPU, we have such a cluster on campus. >> > > That works now, in that you just use more loosely coupled preconditioners, > like ASM. That was my point. > Its unlikely that tightly coupled PCs would be useful in this regime. > > >> Are you familiar with the Magma library? It was recommended recently to >> tackle this problem, >> > > It does not tackle this problem. > > Thanks, > > Matt > > >> I am most interested in your insight, >> >> Thanks, >> >> On Thu, Aug 30, 2018, 3:10 AM Matthew Knepley wrote: >> >>> On Wed, Aug 29, 2018 at 6:21 PM Manuel Valera >>> wrote: >>> >>>> I understand that Matthew, thanks, >>>> >>>> I am trying to see if i get any speedup in this configuration, >>>> otherwise i will be waiting for the MPIAIJ support on PETSc, >>>> >>>> Is there any other gpu preconditioner that works on parallel matrices >>>> directly? >>>> >>> >>> Not that I know of . Such a hypothetical preconditioner would need to >>> pass information back and forth, across the PCI bus, and >>> then through MPI (even if you imagine direct GPU-GPU communication, it >>> still hits the PCI bus). This channel has small bandwidth, >>> but even more limiting is the high latency. Its unclear what kind of >>> algorithm would do well in this situation. >>> >>> Thanks, >>> >>> Matt >>> >>> >>>> Thanks again, >>>> >>>> >>>> >>>> On Wed, Aug 29, 2018 at 3:05 PM, Matthew Knepley >>>> wrote: >>>> >>>>> On Wed, Aug 29, 2018 at 5:49 PM Manuel Valera >>>>> wrote: >>>>> >>>>>> Update: >>>>>> >>>>>> I made it work like you suggested Barry, i had to comment the code >>>>>> line to set up the pc_type saviennacl, that way i am getting as ksp_view: >>>>>> >>>>>> KSP Object: 2 MPI processes >>>>>> type: cg >>>>>> maximum iterations=10000, initial guess is zero >>>>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>>>> left preconditioning >>>>>> using PRECONDITIONED norm type for convergence test >>>>>> PC Object: 2 MPI processes >>>>>> type: bjacobi >>>>>> number of blocks = 2 >>>>>> Local solve is same for all blocks, in the following KSP and PC >>>>>> objects: >>>>>> KSP Object: (sub_) 1 MPI processes >>>>>> type: preonly >>>>>> maximum iterations=10000, initial guess is zero >>>>>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. >>>>>> left preconditioning >>>>>> using NONE norm type for convergence test >>>>>> PC Object: (sub_) 1 MPI processes >>>>>> type: ilu >>>>>> out-of-place factorization >>>>>> 0 levels of fill >>>>>> tolerance for zero pivot 2.22045e-14 >>>>>> matrix ordering: natural >>>>>> factor fill ratio given 1., needed 1. >>>>>> Factored matrix follows: >>>>>> Mat Object: 1 MPI processes >>>>>> type: seqaij >>>>>> rows=75, cols=75 >>>>>> package used to perform factorization: petsc >>>>>> total: nonzeros=927, allocated nonzeros=927 >>>>>> total number of mallocs used during MatSetValues calls =0 >>>>>> not using I-node routines >>>>>> linear system matrix = precond matrix: >>>>>> Mat Object: 1 MPI processes >>>>>> type: seqaijviennacl >>>>>> rows=75, cols=75 >>>>>> total: nonzeros=927, allocated nonzeros=1335 >>>>>> total number of mallocs used during MatSetValues calls =84 >>>>>> not using I-node routines >>>>>> linear system matrix = precond matrix: >>>>>> Mat Object: 2 MPI processes >>>>>> type: mpiaijviennacl >>>>>> rows=125, cols=125 >>>>>> total: nonzeros=1685, allocated nonzeros=2885 >>>>>> total number of mallocs used during MatSetValues calls =184 >>>>>> has attached near null space >>>>>> Press_Max: 1.9995807630564922E-004 >>>>>> >>>>>> >>>>>> This is what we want, right? >>>>>> >>>>>> Still if i try using pc_type saviennacl directly it breaks, >>>>>> >>>>> >>>>> You are missing the point of the error message. >>>>> >>>>> We do not support SAVIENNACL on parallel matrices (MPIAIJ). We do >>>>> support it >>>>> on serial matrices (SEQAIJ). When you are setting in directly, you are >>>>> applying it >>>>> to a parallel matrix. If you use Block-Jacobi, you are applying it to >>>>> each submatrix, >>>>> and those submatrices are all serial. >>>>> >>>>> Thanks, >>>>> >>>>> Matt >>>>> >>>>> >>>>>> Thanks for your help i'll try my speedup like this, >>>>>> >>>>>> >>>>>> >>>>>> >>>>>> >>>>>> On Wed, Aug 29, 2018 at 2:21 PM, Manuel Valera >>>>>> wrote: >>>>>> >>>>>>> Ok, executing with: >>>>>>> >>>>>>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>>>>>> jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view >>>>>>> >>>>>>> >>>>>>> I get: >>>>>>> >>>>>>> >>>>>>> SETTING GPU TYPES >>>>>>> Matrix type: mpiaijviennacl >>>>>>> >>>>>>> Of sizes: 125 x 125 >>>>>>> Matrix type: mpiaijviennacl >>>>>>> >>>>>>> Of sizes: 125 x 125 >>>>>>> [0]PETSC ERROR: --------------------- Error Message >>>>>>> -------------------------------------------------------------- >>>>>>> [0]PETSC ERROR: No support for this operation for this object type >>>>>>> [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>>>>> documentation/faq.html for trouble shooting. >>>>>>> [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>> v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 >>>>>>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>>> Wed Aug 29 14:20:42 2018 >>>>>>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>>>> [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>> [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>> [1]PETSC ERROR: ------------------------------ >>>>>>> ------------------------------------------ >>>>>>> [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>>>> Violation, probably memory access out of range >>>>>>> [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] PetscTraceBackErrorHandler line 182 >>>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>>> [1]PETSC ERROR: [1] PetscError line 352 /home/valera/petsc/src/sys/ >>>>>>> error/err.c >>>>>>> [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>> [1]PETSC ERROR: [1] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >>>>>>> interface/precon.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 Development GIT revision: >>>>>>> v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 >>>>>>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>>> Wed Aug 29 14:20:42 2018 >>>>>>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>>>> [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >>>>>>> ------------------------------------------------------------ >>>>>>> -------------- >>>>>>> MPI_ABORT was invoked on rank 1 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. >>>>>>> ------------------------------------------------------------ >>>>>>> -------------- >>>>>>> [0]PETSC ERROR: ------------------------------ >>>>>>> ------------------------------------------ >>>>>>> [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or >>>>>>> the batch system) has told this process to end >>>>>>> [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. >>>>>>> [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>>>>> /home/valera/petsc/src/sys/objects/tagm.c >>>>>>> [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 >>>>>>> /home/valera/petsc/src/sys/objects/inherit.c >>>>>>> [0]PETSC ERROR: [0] ISCreate line 35 /home/valera/petsc/src/vec/is/ >>>>>>> is/interface/isreg.c >>>>>>> [0]PETSC ERROR: [0] ISCreateGeneral line 658 >>>>>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>>>>> [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>> [0]PETSC ERROR: [0] PCSetUp line 894 /home/valera/petsc/src/ksp/pc/ >>>>>>> interface/precon.c >>>>>>> [0]PETSC ERROR: --------------------- Error Message >>>>>>> -------------------------------------------------------------- >>>>>>> [0]PETSC ERROR: Signal received >>>>>>> [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>>>>> documentation/faq.html for trouble shooting. >>>>>>> [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>> v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 >>>>>>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>>> Wed Aug 29 14:20:42 2018 >>>>>>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>>>> [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >>>>>>> [node50:77836] 1 more process has sent help message help-mpi-api.txt >>>>>>> / mpi-abort >>>>>>> [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to >>>>>>> see all help / error messages >>>>>>> >>>>>>> >>>>>>> >>>>>>> On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. >>>>>> > wrote: >>>>>>> >>>>>>>> Please send complete error message >>>>>>>> >>>>>>>> >>>>>>>> > On Aug 29, 2018, at 3:40 PM, Manuel Valera >>>>>>>> wrote: >>>>>>>> > >>>>>>>> > Yeah, no sorry, i get the same error with -pc_type bjacobi >>>>>>>> -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" >>>>>>>> > >>>>>>>> > >>>>>>>> > Thanks and let me know of any progress on this issue, >>>>>>>> > >>>>>>>> > >>>>>>>> > >>>>>>>> > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera < >>>>>>>> mvalera-w at sdsu.edu> wrote: >>>>>>>> > Awesome, thanks! >>>>>>>> > >>>>>>>> > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. < >>>>>>>> bsmith at mcs.anl.gov> wrote: >>>>>>>> > >>>>>>>> > >>>>>>>> > > On Aug 29, 2018, at 3:26 PM, Manuel Valera >>>>>>>> wrote: >>>>>>>> > > >>>>>>>> > > >>>>>>>> > > >>>>>>>> > > You may need to use just plain PCBJACOBI or PCASM for >>>>>>>> parallelism and then SAVIENNACL sequentially on each block. >>>>>>>> > > >>>>>>>> > > >>>>>>>> > > Can you elaborate a little in how to do this? do you mean i can >>>>>>>> only use viennacl in serial at the moment or this is a suggestion of a >>>>>>>> workaround on how to make it work? >>>>>>>> > >>>>>>>> > -pc_type bjacobi -sub_pc_type SAVIENNACL >>>>>>>> > >>>>>>>> > This will run in parallel and utilize the GPU for each block >>>>>>>> of the preconditioner. >>>>>>>> > >>>>>>>> > Barry >>>>>>>> > >>>>>>>> > > >>>>>>>> > > >>>>>>>> > > Thanks, >>>>>>>> > > >>>>>>>> > > >>>>>>>> > > >>>>>>>> > > >>>>>>>> > > >>>>>>>> > > >>>>>>>> > > >>>>>>>> > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera < >>>>>>>> mvalera-w at sdsu.edu> wrote: >>>>>>>> > > > >>>>>>>> > > > Hi everyone, >>>>>>>> > > > >>>>>>>> > > > Thanks for your responses, i understand communicating on this >>>>>>>> way to this level of technicality can be hard, i still think we can work >>>>>>>> ways to solve this problem though, >>>>>>>> > > > >>>>>>>> > > > I can say the following at this point: >>>>>>>> > > > >>>>>>>> > > > ? Program works without issues in any other non-gpu >>>>>>>> preconditioner, just by calling -pc_type ### . >>>>>>>> > > > ? Program works correctly with ViennaCL preconditioners >>>>>>>> with mpirun -n 1, that is on one processor. >>>>>>>> > > > ? Program breaks with every ViennaCL preconditioner >>>>>>>> when attempting any more than 1 processors. >>>>>>>> > > > ? I haven't tried other GPU preconditioners because >>>>>>>> ViennaCL gave the best performance in 1 processor before. >>>>>>>> > > > ? I have made sure the matrix type is mpiaijviennacl as >>>>>>>> it is printed right before the error log. >>>>>>>> > > > ? I am attaching what i think are the backtrace logs of >>>>>>>> the run with two cores, as i have limited experience with this kind of >>>>>>>> debugging, and i cannot make sense of what they say, please let me know if >>>>>>>> you need me to do something else. >>>>>>>> > > > >>>>>>>> > > > Current options i can think of are giving you permission to >>>>>>>> clone my model repo, or for you to guide me trough the process remotely, >>>>>>>> > > > >>>>>>>> > > > Thanks, >>>>>>>> > > > >>>>>>>> > > > .-.-.-.- >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > The error i get is still: >>>>>>>> > > > >>>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>>> >>>>>>>> > > > Of sizes: 125 x 125 >>>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>>> >>>>>>>> > > > Of sizes: 125 x 125 >>>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>>> -------------------------------------------------------------- >>>>>>>> > > > [0]PETSC ERROR: No support for this operation for this object >>>>>>>> type >>>>>>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>>>> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>>>>>> documentation/faq.html for trouble shooting. >>>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>> > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>>>>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>>>> > > > [1]PETSC ERROR: ------------------------------ >>>>>>>> ------------------------------------------ >>>>>>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>>>>> Violation, probably memory access out of range >>>>>>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>>>>>> /home/valera/petsc/src/sys/error/err.c >>>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>> > > > [1]PETSC ERROR: [1] KSPSetUp line 294 >>>>>>>> /home/valera/petsc/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 Development GIT revision: >>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in >>>>>>>> unknown file >>>>>>>> > > > ------------------------------------------------------------ >>>>>>>> -------------- >>>>>>>> > > > MPI_ABORT was invoked on rank 1 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. >>>>>>>> > > > ------------------------------------------------------------ >>>>>>>> -------------- >>>>>>>> > > > [0]PETSC ERROR: ------------------------------ >>>>>>>> ------------------------------------------ >>>>>>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some >>>>>>>> process (or the batch system) has told this process to end >>>>>>>> > > > [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. >>>>>>>> > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 >>>>>>>> /home/valera/petsc/src/mat/utils/gcreate.c >>>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>> > > > [0]PETSC ERROR: [0] KSPSetUp line 294 >>>>>>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>>> -------------------------------------------------------------- >>>>>>>> > > > [0]PETSC ERROR: Signal received >>>>>>>> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>>>>>> documentation/faq.html for trouble shooting. >>>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>> > > > [0]PETSC ERROR: #4 User provided function() line 0 in >>>>>>>> unknown file >>>>>>>> > > > [node50:32783] 1 more process has sent help message >>>>>>>> help-mpi-api.txt / mpi-abort >>>>>>>> > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" >>>>>>>> to 0 to see all help / error messages >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp < >>>>>>>> rupp at iue.tuwien.ac.at> wrote: >>>>>>>> > > > Hi Manuel, >>>>>>>> > > > >>>>>>>> > > > as Barry said, it is hard for us to provide any help without >>>>>>>> having a more complete picture of what is going on. >>>>>>>> > > > >>>>>>>> > > > The error you report seems to come from the AMG >>>>>>>> preconditioner in ViennaCL. This can have many origins. Do other >>>>>>>> preconditioners run without error? Can you run in a debugger and provide a >>>>>>>> complete backtrace? >>>>>>>> > > > >>>>>>>> > > > Thanks and best regards, >>>>>>>> > > > Karli >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: >>>>>>>> > > > Talked too fast, >>>>>>>> > > > >>>>>>>> > > > After fixing that problem, i tried more than one mpi >>>>>>>> processor and got the following: >>>>>>>> > > > >>>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>>> > > > Of sizes: 125 x 125 >>>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>>> > > > Of sizes: 125 x 125 >>>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>>> -------------------------------------------------------------- >>>>>>>> > > > [0]PETSC ERROR: No support for this operation for this object >>>>>>>> type >>>>>>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>>>> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>>>>>> documentation/faq.html for trouble shooting. >>>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >>>>>>>> http://saviennacl.cu> >>>>>>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>> > > > [1]PETSC ERROR: ------------------------------ >>>>>>>> ------------------------------------------ >>>>>>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>>>>> Violation, probably memory access out of range >>>>>>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>>>>>> /home/valera/petsc/src/sys/error/err.c >>>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>>>>>> http://saviennacl.cu> >>>>>>>> > > > >>>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: >>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in >>>>>>>> unknown file >>>>>>>> > > > ------------------------------------------------------------ >>>>>>>> -------------- >>>>>>>> > > > MPI_ABORT was invoked on rank 1 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. >>>>>>>> > > > ------------------------------------------------------------ >>>>>>>> -------------- >>>>>>>> > > > [0]PETSC ERROR: ------------------------------ >>>>>>>> ------------------------------------------ >>>>>>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some >>>>>>>> process (or the batch system) has told this process to end >>>>>>>> > > > [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. >>>>>>>> > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>>>>>> /home/valera/petsc/src/sys/objects/tagm.c >>>>>>>> > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >>>>>>>> /home/valera/petsc/src/sys/objects/inherit.c >>>>>>>> > > > [0]PETSC ERROR: [0] ISCreate line 35 >>>>>>>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>>>>>>> > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 >>>>>>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>>>>>> http://saviennacl.cu> >>>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>>> -------------------------------------------------------------- >>>>>>>> > > > [0]PETSC ERROR: Signal received >>>>>>>> > > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/ >>>>>>>> documentation/faq.html for trouble shooting. >>>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>> > > > [0]PETSC ERROR: #3 User provided function() line 0 in >>>>>>>> unknown file >>>>>>>> > > > [node50:30582] 1 more process has sent help message >>>>>>>> help-mpi-api.txt / mpi-abort >>>>>>>> > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" >>>>>>>> to 0 to see all help / error messages >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > It is currently running in 1 mpi processor + GPU but i would >>>>>>>> like to call at least 16 mpi processors + GPU to do the rest of the data >>>>>>>> management who is not part of the main laplacian on the mpi and the >>>>>>>> laplacian solution on the GPU, is this currently possible? >>>>>>>> > > > >>>>>>>> > > > Thanks for your help, >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera < >>>>>>>> mvalera-w at sdsu.edu > wrote: >>>>>>>> > > > >>>>>>>> > > > Ok, i found the culprit and we can close this thread, >>>>>>>> > > > >>>>>>>> > > > The problem was a missing variable for setting the >>>>>>>> maximum columns, >>>>>>>> > > > which i deleted at some point without realizing. The >>>>>>>> error message >>>>>>>> > > > was too ambiguous to catch this so i had to compare with >>>>>>>> a previous >>>>>>>> > > > working version of the arguments of MatSetValues, it was >>>>>>>> evident then. >>>>>>>> > > > >>>>>>>> > > > Good news is that i can now set the values with the >>>>>>>> viennacl types too, >>>>>>>> > > > >>>>>>>> > > > Thanks for your kind help, >>>>>>>> > > > >>>>>>>> > > > Manuel >>>>>>>> > > > >>>>>>>> > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >>>>>>>> > > > > wrote: >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > 1) PetscMalloc() is never valid or needed in >>>>>>>> Fortran >>>>>>>> > > > >>>>>>>> > > > 2) there is no reason to use >>>>>>>> DMSetMatrixPreallocateOnly() >>>>>>>> > > > just use DMCreateMatrix() assuming that using a DM >>>>>>>> (DMDA, >>>>>>>> > > > DMPLEX, etc) is suitable for your problem. >>>>>>>> > > > >>>>>>>> > > > At this end we are totally guessing at what you >>>>>>>> are doing >>>>>>>> > > > and so have little help we can provide. A simple, >>>>>>>> nonworking >>>>>>>> > > > code that tries to do what you would need would help >>>>>>>> us a great >>>>>>>> > > > deal in understanding that you are trying to do. >>>>>>>> > > > >>>>>>>> > > > Barry >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera >>>>>>>> > > > > >>>>>>>> wrote: >>>>>>>> > > > > >>>>>>>> > > > > Matthew, PetscMalloc gives the same error, >>>>>>>> > > > > >>>>>>>> > > > > Barry, it would be very hard for me to get the >>>>>>>> code to a >>>>>>>> > > > minimum working example, i guess all i need to >>>>>>>> understand is how >>>>>>>> > > > to setup a DM matrix with >>>>>>>> DMSetMatrixPreallocateOnly() instead >>>>>>>> > > > of MatMPIAIJSetPreallocation() as we were doing >>>>>>>> before, is there >>>>>>>> > > > a simple example who does this in Fortran? >>>>>>>> > > > > >>>>>>>> > > > > Is the PetscMalloc call needed? is 'call >>>>>>>> > > > PetscMalloc(1,row,ierr)' a valid, compilable call to >>>>>>>> > > > PetscMalloc? what other reason may there be for this >>>>>>>> error to >>>>>>>> > > > happen ? >>>>>>>> > > > > >>>>>>>> > > > > Just remembering, that trying to setup the matrix >>>>>>>> with the >>>>>>>> > > > MatAIJSetPreallocation() brings up an error to >>>>>>>> acknowledge the >>>>>>>> > > > viennacl datatypes and that's why i'm trying to make >>>>>>>> this change >>>>>>>> > > > on your recommendation, >>>>>>>> > > > > >>>>>>>> > > > > Thanks for your help, >>>>>>>> > > > > >>>>>>>> > > > > >>>>>>>> > > > > >>>>>>>> > > > > >>>>>>>> > > > > >>>>>>>> > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >>>>>>>> > > > > >>>>>>>> wrote: >>>>>>>> > > > > >>>>>>>> > > > > Send your code in a way we can compile and run >>>>>>>> it; it must >>>>>>>> > > > be some simple issue that is hard to communicate in >>>>>>>> email. >>>>>>>> > > > > >>>>>>>> > > > > Barry >>>>>>>> > > > > >>>>>>>> > > > > >>>>>>>> > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >>>>>>>> > > > > >>>>>>>> wrote: >>>>>>>> > > > > > >>>>>>>> > > > > > Hello everyone, >>>>>>>> > > > > > >>>>>>>> > > > > > I just had time to work on this again, and >>>>>>>> checked the code >>>>>>>> > > > for errors on the matrix entries, this is the exact >>>>>>>> code i was >>>>>>>> > > > using for creating the matrix without >>>>>>>> > > > DMSetMatrixPreallocateOnly, using >>>>>>>> MatMPIAIJSetPreallocation and >>>>>>>> > > > it worked that way, but trying this way i get the >>>>>>>> same 'Column >>>>>>>> > > > too large' error using any number at the column >>>>>>>> position of >>>>>>>> > > > MatSetValues, >>>>>>>> > > > > > >>>>>>>> > > > > > I have set up my code to print the column >>>>>>>> argument (n) of >>>>>>>> > > > MatSetValues and in this case is 7 (lower than 124), >>>>>>>> it still >>>>>>>> > > > gives error, even entering a specific number in the >>>>>>>> MatSetValues >>>>>>>> > > > column argument position gives the same error. >>>>>>>> > > > > > >>>>>>>> > > > > > So next i went back to ex.50 here: >>>>>>>> > > > http://www.mcs.anl.gov/petsc/ >>>>>>>> petsc-current/src/ts/examples/tutorials/ex50.c.html >>>>>>>> > > > >>>>>>> examples/tutorials/ex50.c.html> >>>>>>>> > > > and it has a very similar structure except the >>>>>>>> PetscMalloc1() >>>>>>>> > > > call, so i tried adding that and got: >>>>>>>> > > > > > >>>>>>>> > > > > > /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: >>>>>>>> undefined >>>>>>>> > > > reference to `petscmalloc1_' >>>>>>>> > > > > > >>>>>>>> > > > > > Any ideas on this behaviour? >>>>>>>> > > > > > >>>>>>>> > > > > > Thanks so much, >>>>>>>> > > > > > >>>>>>>> > > > > > >>>>>>>> > > > > > >>>>>>>> > > > > > >>>>>>>> > > > > > >>>>>>>> > > > > > >>>>>>>> > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry F. >>>>>>>> > > > > >>>>>>>> wrote: >>>>>>>> > > > > > >>>>>>>> > > > > > Column too large: col 10980 max 124 >>>>>>>> > > > > > >>>>>>>> > > > > > You need to check the code that is generating >>>>>>>> the matrix >>>>>>>> > > > entries. The matrix has 124 columns but you are >>>>>>>> attempting to >>>>>>>> > > > put a value at column 10980 >>>>>>>> > > > > > >>>>>>>> > > > > > Barry >>>>>>>> > > > > > >>>>>>>> > > > > > >>>>>>>> > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >>>>>>>> > > > > >>>>>>>> wrote: >>>>>>>> > > > > > > >>>>>>>> > > > > > > Thanks Matthew and Barry, >>>>>>>> > > > > > > >>>>>>>> > > > > > > Now my code looks like: >>>>>>>> > > > > > > >>>>>>>> > > > > > > call DMSetMatrixPreallocateOnly( >>>>>>>> daDummy,PETSC_TRUE,ierr) >>>>>>>> > > > > > > call DMSetMatType(daDummy, >>>>>>>> MATMPIAIJVIENNACL,ierr) >>>>>>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>>> > > > > > > call MatSetFromOptions(A,ierr) >>>>>>>> > > > > > > call MatSetUp(A,ierr) >>>>>>>> > > > > > > [...] >>>>>>>> > > > > > > call >>>>>>>> > > > MatSetValues(A,1,row,sumpos, >>>>>>>> pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>>> > > > > > > [...] >>>>>>>> > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, >>>>>>>> ierr) >>>>>>>> > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, >>>>>>>> ierr) >>>>>>>> > > > > > > >>>>>>>> > > > > > > And i get a different error, now is: >>>>>>>> > > > > > > >>>>>>>> > > > > > > [0]PETSC ERROR: --------------------- Error >>>>>>>> Message >>>>>>>> > > > ----------------------------- >>>>>>>> --------------------------------- >>>>>>>> > > > > > > [0]PETSC ERROR: Argument out of range >>>>>>>> > > > > > > [0]PETSC ERROR: Column too large: col 10980 >>>>>>>> max 124 >>>>>>>> > > > > > > [0]PETSC ERROR: See >>>>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>>>> > > > >>>>>>>> for >>>>>>>> > > > trouble shooting. >>>>>>>> > > > > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 >>>>>>>> +0300 >>>>>>>> > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>>>>> named node50 >>>>>>>> > > > by valera Wed Aug 15 19:40:00 2018 >>>>>>>> > > > > > > [0]PETSC ERROR: Configure options >>>>>>>> PETSC_ARCH=cuda-debug >>>>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>>>> --with-shared-libraries=1 >>>>>>>> > > > --with-debugging=1 --with-cuda=1 >>>>>>>> --CUDAFLAGS=-arch=sm_60 >>>>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>> > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line >>>>>>>> 442 in >>>>>>>> > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c >>>>>>>> > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>>>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > Thanks again, >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry >>>>>>>> F. >>>>>>>> > > > > >>>>>>>> wrote: >>>>>>>> > > > > > > >>>>>>>> > > > > > > Should be >>>>>>>> > > > > > > >>>>>>>> > > > > > > call DMSetMatType(daDummy, >>>>>>>> MATMPIAIJVIENNACL,ierr) >>>>>>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>>> > > > > > > >>>>>>>> > > > > > > and remove the rest. You need to set the >>>>>>>> type of Mat >>>>>>>> > > > you want the DM to return BEFORE you create the >>>>>>>> matrix. >>>>>>>> > > > > > > >>>>>>>> > > > > > > Barry >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >>>>>>>> > > > > >>>>>>>> wrote: >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Ok thanks for clarifying that, i wasn't sure >>>>>>>> if there >>>>>>>> > > > were different types, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Here is a stripped down version of my code, >>>>>>>> it seems >>>>>>>> > > > like the preallocation is working now since the matrix >>>>>>>> > > > population part is working without problem, but here >>>>>>>> it is for >>>>>>>> > > > illustration purposes: >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > call DMSetMatrixPreallocateOnly( >>>>>>>> daDummy,PETSC_TRUE,ierr) >>>>>>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>>>>>> > > > > > > > call DMSetMatType(daDummy, >>>>>>>> MATMPIAIJVIENNACL,ierr) >>>>>>>> > > > > > > > call DMSetVecType(daDummy, >>>>>>>> VECMPIVIENNACL,ierr) >>>>>>>> > > > > > > > call >>>>>>>> > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>>>>>>> PETSC_NULL_INTEGER,ierr) >>>>>>>> > > > > > > > call MatSetUp(A,ierr) >>>>>>>> > > > > > > > [...] >>>>>>>> > > > > > > > call >>>>>>>> > > > MatSetValues(A,1,row,sumpos, >>>>>>>> pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>>> > > > > > > > [...] >>>>>>>> > > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, >>>>>>>> ierr) >>>>>>>> > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, >>>>>>>> ierr) >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Adding the first line there did the trick, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Now the problem seems to be the program is >>>>>>>> not >>>>>>>> > > > recognizing the matrix as ViennaCL type when i try >>>>>>>> with more >>>>>>>> > > > than one processor, i get now: >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > [0]PETSC ERROR: --------------------- Error >>>>>>>> Message >>>>>>>> > > > ----------------------------- >>>>>>>> --------------------------------- >>>>>>>> > > > > > > > [0]PETSC ERROR: No support for this >>>>>>>> operation for this >>>>>>>> > > > object type >>>>>>>> > > > > > > > [0]PETSC ERROR: Currently only handles >>>>>>>> ViennaCL matrices >>>>>>>> > > > > > > > [0]PETSC ERROR: See >>>>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>>>> > > > >>>>>>>> for >>>>>>>> > > > trouble shooting. >>>>>>>> > > > > > > > [0]PETSC ERROR: Petsc Development GIT >>>>>>>> revision: >>>>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 >>>>>>>> +0300 >>>>>>>> > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>>>>> named >>>>>>>> > > > node50 by valera Wed Aug 15 14:44:22 2018 >>>>>>>> > > > > > > > [0]PETSC ERROR: Configure options >>>>>>>> PETSC_ARCH=cuda-debug >>>>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>>>> --with-shared-libraries=1 >>>>>>>> > > > --with-debugging=1 --with-cuda=1 >>>>>>>> --CUDAFLAGS=-arch=sm_60 >>>>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>> > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line >>>>>>>> 47 in >>>>>>>> > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/ >>>>>>>> saviennacl.cu >>>>>>>> > > > >>>>>>>> > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>>> > > > /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>> > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>>>>>> > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > When running with: >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > mpirun -n 1 ./gcmLEP.GPU >>>>>>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ >>>>>>>> jid=tiny_cuda_test_n2 >>>>>>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>>>>> aijviennacl >>>>>>>> > > > -pc_type saviennacl -log_view >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Thanks, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew >>>>>>>> Knepley >>>>>>>> > > > > wrote: >>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel Valera >>>>>>>> > > > > >>>>>>>> wrote: >>>>>>>> > > > > > > > It seems to be resumed on: I do not know how >>>>>>>> to >>>>>>>> > > > preallocate a DM Matrix correctly. >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > There is only one matrix type, Mat. There >>>>>>>> are no >>>>>>>> > > > separate DM matrices. A DM can create a matrix for you >>>>>>>> > > > > > > > using DMCreateMatrix(), but that is a Mat >>>>>>>> and it is >>>>>>>> > > > preallocated correctly. I am not sure what you are >>>>>>>> doing. >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Thanks, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Matt >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > The interesting part is that it only breaks >>>>>>>> when i need >>>>>>>> > > > to populate a GPU matrix from MPI, so kudos on that, >>>>>>>> but it >>>>>>>> > > > seems i need to do better on my code to get this >>>>>>>> setup working, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Any help would be appreciated, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Thanks, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew >>>>>>>> Knepley >>>>>>>> > > > > wrote: >>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel Valera >>>>>>>> > > > > >>>>>>>> wrote: >>>>>>>> > > > > > > > Thanks Matthew, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > I try to do that when calling: >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > call >>>>>>>> > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>>>>>>> PETSC_NULL_INTEGER,ierr) >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > But i am not aware on how to do this for the >>>>>>>> DM if it >>>>>>>> > > > needs something more specific/different, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > The error says that your preallocation is >>>>>>>> wrong for the >>>>>>>> > > > values you are putting in. The DM does not control >>>>>>>> either, >>>>>>>> > > > > > > > so I do not understand your email. >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Thanks, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Matt >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Thanks, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew >>>>>>>> Knepley >>>>>>>> > > > > wrote: >>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel Valera >>>>>>>> > > > > >>>>>>>> wrote: >>>>>>>> > > > > > > > Hello PETSc devs, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > I am running into an error when trying to >>>>>>>> use the >>>>>>>> > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same >>>>>>>> code runs >>>>>>>> > > > for MATSEQAIJVIENNACL type in one processor. The >>>>>>>> error happens >>>>>>>> > > > when calling MatSetValues for this specific >>>>>>>> configuration. It >>>>>>>> > > > does not occur when using MPI DMMatrix types only. >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > The DM properly preallocates the matrix. I >>>>>>>> am assuming >>>>>>>> > > > you do not here. >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Matt >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Any help will be appreciated, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > Thanks, >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > My program call: >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > mpirun -n 2 ./gcmLEP.GPU >>>>>>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ >>>>>>>> jid=tiny_cuda_test_n2 >>>>>>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>>>>> aijviennacl >>>>>>>> > > > -pc_type saviennacl -log_view >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > The error (repeats after each MatSetValues >>>>>>>> call): >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > [1]PETSC ERROR: --------------------- Error >>>>>>>> Message >>>>>>>> > > > ----------------------------- >>>>>>>> --------------------------------- >>>>>>>> > > > > > > > [1]PETSC ERROR: Argument out of range >>>>>>>> > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at >>>>>>>> global >>>>>>>> > > > row/column (75, 50) into matrix >>>>>>>> > > > > > > > [1]PETSC ERROR: See >>>>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>>>> > > > >>>>>>>> for >>>>>>>> > > > trouble shooting. >>>>>>>> > > > > > > > [1]PETSC ERROR: Petsc Development GIT >>>>>>>> revision: >>>>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 >>>>>>>> +0300 >>>>>>>> > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>>>>> named >>>>>>>> > > > node50 by valera Wed Aug 15 13:10:44 2018 >>>>>>>> > > > > > > > [1]PETSC ERROR: Configure options >>>>>>>> PETSC_ARCH=cuda-debug >>>>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>>>> --with-shared-libraries=1 >>>>>>>> > > > --with-debugging=1 --with-cuda=1 >>>>>>>> --CUDAFLAGS=-arch=sm_60 >>>>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>> > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() >>>>>>>> line 608 in >>>>>>>> > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>>>>>>> > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 >>>>>>>> in >>>>>>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > My Code structure: >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>>>>>> > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, >>>>>>>> numprocs, ierr) >>>>>>>> > > > > > > > if (numprocs > 1) then ! set matrix type >>>>>>>> parallel >>>>>>>> > > > > > > > ! Get local size >>>>>>>> > > > > > > > call DMDACreateNaturalVector( >>>>>>>> daDummy,Tmpnat,ierr) >>>>>>>> > > > > > > > call VecGetLocalSize(Tmpnat, >>>>>>>> locsize,ierr) >>>>>>>> > > > > > > > call VecDestroy(Tmpnat,ierr) >>>>>>>> > > > > > > > ! Set matrix >>>>>>>> > > > > > > > #ifdef GPU >>>>>>>> > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >>>>>>>> > > > > > > > call DMSetMatType(daDummy, >>>>>>>> MATMPIAIJVIENNACL,ierr) >>>>>>>> > > > > > > > call DMSetVecType(daDummy, >>>>>>>> VECMPIVIENNACL,ierr) >>>>>>>> > > > > > > > print*,'SETTING GPU TYPES' >>>>>>>> > > > > > > > #else >>>>>>>> > > > > > > > call DMSetMatType(daDummy, >>>>>>>> MATMPIAIJ,ierr) >>>>>>>> > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) >>>>>>>> > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! >>>>>>>> > > > > > > > #endif >>>>>>>> > > > > > > > call >>>>>>>> > > > MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19, >>>>>>>> PETSC_NULL_INTEGER,ierr) >>>>>>>> > > > > > > > else ! set matrix type >>>>>>>> sequential >>>>>>>> > > > > > > > #ifdef GPU >>>>>>>> > > > > > > > call DMSetMatType(daDummy, >>>>>>>> MATSEQAIJVIENNACL,ierr) >>>>>>>> > > > > > > > call DMSetVecType(daDummy, >>>>>>>> VECSEQVIENNACL,ierr) >>>>>>>> > > > > > > > call MatSetType(A, >>>>>>>> MATSEQAIJVIENNACL,ierr) >>>>>>>> > > > > > > > print*,'SETTING GPU TYPES' >>>>>>>> > > > > > > > #else >>>>>>>> > > > > > > > call DMSetMatType(daDummy, >>>>>>>> MATSEQAIJ,ierr) >>>>>>>> > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >>>>>>>> > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) >>>>>>>> > > > > > > > #endif >>>>>>>> > > > > > > > call MatSetUp(A,ierr) >>>>>>>> > > > > > > > call >>>>>>>> > > > getCenterInfo(daGrid,xstart, >>>>>>>> ystart,zstart,xend,yend,zend) >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > do k=zstart,zend-1 >>>>>>>> > > > > > > > do j=ystart,yend-1 >>>>>>>> > > > > > > > do i=xstart,xend-1 >>>>>>>> > > > > > > > [..] >>>>>>>> > > > > > > > call >>>>>>>> > > > MatSetValues(A,1,row,sumpos, >>>>>>>> pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>>> > > > > > > > [..] >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > -- >>>>>>>> > > > > > > > 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 >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>>>> > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > -- >>>>>>>> > > > > > > > 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 >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>>>> > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > -- >>>>>>>> > > > > > > > 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 >>>>>>>> > > > > > > > >>>>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>>>> > > > >>>>>>>> > > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > > >>>>>>>> > > > > > >>>>>>>> > > > > > >>>>>>>> > > > > >>>>>>>> > > > > >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > > > >>>>>>>> > >>>>>>>> > >>>>>>>> > >>>>>>>> >>>>>>>> >>>>>>> >>>>>> >>>>> >>>>> -- >>>>> 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 >>>>> >>>>> https://www.cse.buffalo.edu/~knepley/ >>>>> >>>>> >>>> >>>> >>> >>> -- >>> 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 >>> >>> https://www.cse.buffalo.edu/~knepley/ >>> >>> >> > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Thu Aug 30 15:45:20 2018 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 30 Aug 2018 16:45:20 -0400 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: References: <5236F216-FA52-454C-8C52-8781D05439A2@anl.gov> <85CD95CE-D795-40BC-9124-FFF3CCF4CD40@mcs.anl.gov> <88CA97E1-E1C1-45D4-A403-B7BA8EDCF981@mcs.anl.gov> <52b689a6-b079-bf1b-7137-5b1637a39504@iue.tuwien.ac.at> <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> Message-ID: On Thu, Aug 30, 2018 at 4:41 PM Manuel Valera wrote: > Matthew, and anyone who wants to chip in on this, > > Just to close this thread then, can you suggest a roadmap to get this > MPI+GPU hibrydization done? you mentioned the ASM PCs, i may look into > that, but is not clear to me now if this is doable now in PETSc or if i > have to wait for more functionality to be added, > This is doable now. First select ASM (-pc_type asm). The serial submatrices should be of the correct type. Then select the subsolver to be your favorite GPU thing (-sub_pc_type saviennacl). > I have two available machines, one with 20 cores and a P100 GPU, and other > with 8 V100 GPUs and MPI for communication, how would you guys do this? > The above is appropriate for this setup. Thanks, Matt > My model is fully distributed with DMDAs except for output, and the linear > solver takes around 56% of the computation time, > > Thanks, > > > > > > On Thu, Aug 30, 2018 at 8:25 AM, Matthew Knepley > wrote: > >> On Thu, Aug 30, 2018 at 10:52 AM Manuel Valera >> wrote: >> >>> I thought newer NVIDIA cards had integrated circuits, not using PCI >>> anymore, still the same case? >>> >>> How would the GPU clusters work, then? Let's say i have a cluster of >>> GPUs communicated by an MPI node, would PETSc work on this configuration at >>> some point? This would be my next step if I could make the MPI matrices >>> work with GPU, we have such a cluster on campus. >>> >> >> That works now, in that you just use more loosely coupled >> preconditioners, like ASM. That was my point. >> Its unlikely that tightly coupled PCs would be useful in this regime. >> >> >>> Are you familiar with the Magma library? It was recommended recently to >>> tackle this problem, >>> >> >> It does not tackle this problem. >> >> Thanks, >> >> Matt >> >> >>> I am most interested in your insight, >>> >>> Thanks, >>> >>> On Thu, Aug 30, 2018, 3:10 AM Matthew Knepley wrote: >>> >>>> On Wed, Aug 29, 2018 at 6:21 PM Manuel Valera >>>> wrote: >>>> >>>>> I understand that Matthew, thanks, >>>>> >>>>> I am trying to see if i get any speedup in this configuration, >>>>> otherwise i will be waiting for the MPIAIJ support on PETSc, >>>>> >>>>> Is there any other gpu preconditioner that works on parallel matrices >>>>> directly? >>>>> >>>> >>>> Not that I know of . Such a hypothetical preconditioner would need to >>>> pass information back and forth, across the PCI bus, and >>>> then through MPI (even if you imagine direct GPU-GPU communication, it >>>> still hits the PCI bus). This channel has small bandwidth, >>>> but even more limiting is the high latency. Its unclear what kind of >>>> algorithm would do well in this situation. >>>> >>>> Thanks, >>>> >>>> Matt >>>> >>>> >>>>> Thanks again, >>>>> >>>>> >>>>> >>>>> On Wed, Aug 29, 2018 at 3:05 PM, Matthew Knepley >>>>> wrote: >>>>> >>>>>> On Wed, Aug 29, 2018 at 5:49 PM Manuel Valera >>>>>> wrote: >>>>>> >>>>>>> Update: >>>>>>> >>>>>>> I made it work like you suggested Barry, i had to comment the code >>>>>>> line to set up the pc_type saviennacl, that way i am getting as ksp_view: >>>>>>> >>>>>>> KSP Object: 2 MPI processes >>>>>>> type: cg >>>>>>> maximum iterations=10000, initial guess is zero >>>>>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>>>>> left preconditioning >>>>>>> using PRECONDITIONED norm type for convergence test >>>>>>> PC Object: 2 MPI processes >>>>>>> type: bjacobi >>>>>>> number of blocks = 2 >>>>>>> Local solve is same for all blocks, in the following KSP and PC >>>>>>> objects: >>>>>>> KSP Object: (sub_) 1 MPI processes >>>>>>> type: preonly >>>>>>> maximum iterations=10000, initial guess is zero >>>>>>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. >>>>>>> left preconditioning >>>>>>> using NONE norm type for convergence test >>>>>>> PC Object: (sub_) 1 MPI processes >>>>>>> type: ilu >>>>>>> out-of-place factorization >>>>>>> 0 levels of fill >>>>>>> tolerance for zero pivot 2.22045e-14 >>>>>>> matrix ordering: natural >>>>>>> factor fill ratio given 1., needed 1. >>>>>>> Factored matrix follows: >>>>>>> Mat Object: 1 MPI processes >>>>>>> type: seqaij >>>>>>> rows=75, cols=75 >>>>>>> package used to perform factorization: petsc >>>>>>> total: nonzeros=927, allocated nonzeros=927 >>>>>>> total number of mallocs used during MatSetValues calls =0 >>>>>>> not using I-node routines >>>>>>> linear system matrix = precond matrix: >>>>>>> Mat Object: 1 MPI processes >>>>>>> type: seqaijviennacl >>>>>>> rows=75, cols=75 >>>>>>> total: nonzeros=927, allocated nonzeros=1335 >>>>>>> total number of mallocs used during MatSetValues calls =84 >>>>>>> not using I-node routines >>>>>>> linear system matrix = precond matrix: >>>>>>> Mat Object: 2 MPI processes >>>>>>> type: mpiaijviennacl >>>>>>> rows=125, cols=125 >>>>>>> total: nonzeros=1685, allocated nonzeros=2885 >>>>>>> total number of mallocs used during MatSetValues calls =184 >>>>>>> has attached near null space >>>>>>> Press_Max: 1.9995807630564922E-004 >>>>>>> >>>>>>> >>>>>>> This is what we want, right? >>>>>>> >>>>>>> Still if i try using pc_type saviennacl directly it breaks, >>>>>>> >>>>>> >>>>>> You are missing the point of the error message. >>>>>> >>>>>> We do not support SAVIENNACL on parallel matrices (MPIAIJ). We do >>>>>> support it >>>>>> on serial matrices (SEQAIJ). When you are setting in directly, you >>>>>> are applying it >>>>>> to a parallel matrix. If you use Block-Jacobi, you are applying it to >>>>>> each submatrix, >>>>>> and those submatrices are all serial. >>>>>> >>>>>> Thanks, >>>>>> >>>>>> Matt >>>>>> >>>>>> >>>>>>> Thanks for your help i'll try my speedup like this, >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>>> >>>>>>> On Wed, Aug 29, 2018 at 2:21 PM, Manuel Valera >>>>>>> wrote: >>>>>>> >>>>>>>> Ok, executing with: >>>>>>>> >>>>>>>> mpirun -n 2 ./gcmLEP.GPU tc=TestCases/LockRelease/LE_6x6x6/ >>>>>>>> jid=tiny_cuda_test_n1 -pc_type bjacobi -pc_sub_type saviennacl -ksp_view >>>>>>>> >>>>>>>> >>>>>>>> I get: >>>>>>>> >>>>>>>> >>>>>>>> SETTING GPU TYPES >>>>>>>> Matrix type: mpiaijviennacl >>>>>>>> >>>>>>>> Of sizes: 125 x 125 >>>>>>>> Matrix type: mpiaijviennacl >>>>>>>> >>>>>>>> Of sizes: 125 x 125 >>>>>>>> [0]PETSC ERROR: --------------------- Error Message >>>>>>>> -------------------------------------------------------------- >>>>>>>> [0]PETSC ERROR: No support for this operation for this object type >>>>>>>> [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>>>> [0]PETSC ERROR: See >>>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>>> shooting. >>>>>>>> [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>> v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 >>>>>>>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>>>> Wed Aug 29 14:20:42 2018 >>>>>>>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>>>>> [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>>> [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>> [1]PETSC ERROR: >>>>>>>> ------------------------------------------------------------------------ >>>>>>>> [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>>>>> Violation, probably memory access out of range >>>>>>>> [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] PetscTraceBackErrorHandler line 182 >>>>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>>>> [1]PETSC ERROR: [1] PetscError line 352 >>>>>>>> /home/valera/petsc/src/sys/error/err.c >>>>>>>> [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>>> [1]PETSC ERROR: [1] PCSetUp line 894 >>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: >>>>>>>> v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 >>>>>>>> [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>>>> Wed Aug 29 14:20:42 2018 >>>>>>>> [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>>>>> [1]PETSC ERROR: #1 User provided function() line 0 in unknown file >>>>>>>> >>>>>>>> -------------------------------------------------------------------------- >>>>>>>> MPI_ABORT was invoked on rank 1 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. >>>>>>>> >>>>>>>> -------------------------------------------------------------------------- >>>>>>>> [0]PETSC ERROR: >>>>>>>> ------------------------------------------------------------------------ >>>>>>>> [0]PETSC ERROR: Caught signal number 15 Terminate: Some process (or >>>>>>>> the batch system) has told this process to end >>>>>>>> [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. >>>>>>>> [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>>>>>> /home/valera/petsc/src/sys/objects/tagm.c >>>>>>>> [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 41 >>>>>>>> /home/valera/petsc/src/sys/objects/inherit.c >>>>>>>> [0]PETSC ERROR: [0] ISCreate line 35 >>>>>>>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>>>>>>> [0]PETSC ERROR: [0] ISCreateGeneral line 658 >>>>>>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>>>>>> [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>>> [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>> [0]PETSC ERROR: --------------------- Error Message >>>>>>>> -------------------------------------------------------------- >>>>>>>> [0]PETSC ERROR: Signal received >>>>>>>> [0]PETSC ERROR: See >>>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>>> shooting. >>>>>>>> [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>> v3.9.3-1264-g6fb0cd4 GIT Date: 2018-08-29 12:42:36 -0600 >>>>>>>> [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by valera >>>>>>>> Wed Aug 29 14:20:42 2018 >>>>>>>> [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>> --with-cc=mpicc --with-cxx=mpic++ --with-fc=mpifort --COPTFLAGS=-O2 >>>>>>>> --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 --with-shared-libraries=1 >>>>>>>> --with-debugging=1 --with-cuda=1 --CUDAFLAGS=-arch=sm_60 >>>>>>>> --with-blaslapack-dir=/usr/lib64 --download-viennacl --download-cusp >>>>>>>> [0]PETSC ERROR: #3 User provided function() line 0 in unknown file >>>>>>>> [node50:77836] 1 more process has sent help message >>>>>>>> help-mpi-api.txt / mpi-abort >>>>>>>> [node50:77836] Set MCA parameter "orte_base_help_aggregate" to 0 to >>>>>>>> see all help / error messages >>>>>>>> >>>>>>>> >>>>>>>> >>>>>>>> On Wed, Aug 29, 2018 at 2:02 PM, Smith, Barry F. < >>>>>>>> bsmith at mcs.anl.gov> wrote: >>>>>>>> >>>>>>>>> Please send complete error message >>>>>>>>> >>>>>>>>> >>>>>>>>> > On Aug 29, 2018, at 3:40 PM, Manuel Valera >>>>>>>>> wrote: >>>>>>>>> > >>>>>>>>> > Yeah, no sorry, i get the same error with -pc_type bjacobi >>>>>>>>> -sub_pc_type SAVIENNACL : "Currently only handles ViennaCL matrices" >>>>>>>>> > >>>>>>>>> > >>>>>>>>> > Thanks and let me know of any progress on this issue, >>>>>>>>> > >>>>>>>>> > >>>>>>>>> > >>>>>>>>> > On Wed, Aug 29, 2018 at 1:37 PM, Manuel Valera < >>>>>>>>> mvalera-w at sdsu.edu> wrote: >>>>>>>>> > Awesome, thanks! >>>>>>>>> > >>>>>>>>> > On Wed, Aug 29, 2018 at 1:29 PM, Smith, Barry F. < >>>>>>>>> bsmith at mcs.anl.gov> wrote: >>>>>>>>> > >>>>>>>>> > >>>>>>>>> > > On Aug 29, 2018, at 3:26 PM, Manuel Valera >>>>>>>>> wrote: >>>>>>>>> > > >>>>>>>>> > > >>>>>>>>> > > >>>>>>>>> > > You may need to use just plain PCBJACOBI or PCASM for >>>>>>>>> parallelism and then SAVIENNACL sequentially on each block. >>>>>>>>> > > >>>>>>>>> > > >>>>>>>>> > > Can you elaborate a little in how to do this? do you mean i >>>>>>>>> can only use viennacl in serial at the moment or this is a suggestion of a >>>>>>>>> workaround on how to make it work? >>>>>>>>> > >>>>>>>>> > -pc_type bjacobi -sub_pc_type SAVIENNACL >>>>>>>>> > >>>>>>>>> > This will run in parallel and utilize the GPU for each block >>>>>>>>> of the preconditioner. >>>>>>>>> > >>>>>>>>> > Barry >>>>>>>>> > >>>>>>>>> > > >>>>>>>>> > > >>>>>>>>> > > Thanks, >>>>>>>>> > > >>>>>>>>> > > >>>>>>>>> > > >>>>>>>>> > > >>>>>>>>> > > >>>>>>>>> > > >>>>>>>>> > > >>>>>>>>> > > > On Aug 29, 2018, at 1:50 PM, Manuel Valera < >>>>>>>>> mvalera-w at sdsu.edu> wrote: >>>>>>>>> > > > >>>>>>>>> > > > Hi everyone, >>>>>>>>> > > > >>>>>>>>> > > > Thanks for your responses, i understand communicating on >>>>>>>>> this way to this level of technicality can be hard, i still think we can >>>>>>>>> work ways to solve this problem though, >>>>>>>>> > > > >>>>>>>>> > > > I can say the following at this point: >>>>>>>>> > > > >>>>>>>>> > > > ? Program works without issues in any other non-gpu >>>>>>>>> preconditioner, just by calling -pc_type ### . >>>>>>>>> > > > ? Program works correctly with ViennaCL >>>>>>>>> preconditioners with mpirun -n 1, that is on one processor. >>>>>>>>> > > > ? Program breaks with every ViennaCL preconditioner >>>>>>>>> when attempting any more than 1 processors. >>>>>>>>> > > > ? I haven't tried other GPU preconditioners because >>>>>>>>> ViennaCL gave the best performance in 1 processor before. >>>>>>>>> > > > ? I have made sure the matrix type is mpiaijviennacl >>>>>>>>> as it is printed right before the error log. >>>>>>>>> > > > ? I am attaching what i think are the backtrace logs >>>>>>>>> of the run with two cores, as i have limited experience with this kind of >>>>>>>>> debugging, and i cannot make sense of what they say, please let me know if >>>>>>>>> you need me to do something else. >>>>>>>>> > > > >>>>>>>>> > > > Current options i can think of are giving you permission to >>>>>>>>> clone my model repo, or for you to guide me trough the process remotely, >>>>>>>>> > > > >>>>>>>>> > > > Thanks, >>>>>>>>> > > > >>>>>>>>> > > > .-.-.-.- >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > The error i get is still: >>>>>>>>> > > > >>>>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>>>> >>>>>>>>> > > > Of sizes: 125 x 125 >>>>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>>>> >>>>>>>>> > > > Of sizes: 125 x 125 >>>>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>>>> -------------------------------------------------------------- >>>>>>>>> > > > [0]PETSC ERROR: No support for this operation for this >>>>>>>>> object type >>>>>>>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>>>>> > > > [0]PETSC ERROR: See >>>>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>>>> shooting. >>>>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>>> > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>>>>>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>>>>> > > > [1]PETSC ERROR: >>>>>>>>> ------------------------------------------------------------------------ >>>>>>>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>>>>>> Violation, probably memory access out of range >>>>>>>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>>>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>>>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>>>>>>> /home/valera/petsc/src/sys/error/err.c >>>>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>>> > > > [1]PETSC ERROR: [1] KSPSetUp line 294 >>>>>>>>> /home/valera/petsc/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 Development GIT revision: >>>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>>>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in >>>>>>>>> unknown file >>>>>>>>> > > > >>>>>>>>> -------------------------------------------------------------------------- >>>>>>>>> > > > MPI_ABORT was invoked on rank 1 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. >>>>>>>>> > > > >>>>>>>>> -------------------------------------------------------------------------- >>>>>>>>> > > > [0]PETSC ERROR: >>>>>>>>> ------------------------------------------------------------------------ >>>>>>>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some >>>>>>>>> process (or the batch system) has told this process to end >>>>>>>>> > > > [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. >>>>>>>>> > > > [0]PETSC ERROR: [0] MatSetErrorIfFailure line 116 >>>>>>>>> /home/valera/petsc/src/mat/utils/gcreate.c >>>>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu >>>>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>>> > > > [0]PETSC ERROR: [0] KSPSetUp line 294 >>>>>>>>> /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>>>> -------------------------------------------------------------- >>>>>>>>> > > > [0]PETSC ERROR: Signal received >>>>>>>>> > > > [0]PETSC ERROR: See >>>>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>>>> shooting. >>>>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>>> valera Wed Aug 29 11:43:25 2018 >>>>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>>> > > > [0]PETSC ERROR: #4 User provided function() line 0 in >>>>>>>>> unknown file >>>>>>>>> > > > [node50:32783] 1 more process has sent help message >>>>>>>>> help-mpi-api.txt / mpi-abort >>>>>>>>> > > > [node50:32783] Set MCA parameter "orte_base_help_aggregate" >>>>>>>>> to 0 to see all help / error messages >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > On Tue, Aug 28, 2018 at 9:34 PM, Karl Rupp < >>>>>>>>> rupp at iue.tuwien.ac.at> wrote: >>>>>>>>> > > > Hi Manuel, >>>>>>>>> > > > >>>>>>>>> > > > as Barry said, it is hard for us to provide any help without >>>>>>>>> having a more complete picture of what is going on. >>>>>>>>> > > > >>>>>>>>> > > > The error you report seems to come from the AMG >>>>>>>>> preconditioner in ViennaCL. This can have many origins. Do other >>>>>>>>> preconditioners run without error? Can you run in a debugger and provide a >>>>>>>>> complete backtrace? >>>>>>>>> > > > >>>>>>>>> > > > Thanks and best regards, >>>>>>>>> > > > Karli >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > On 08/29/2018 01:33 AM, Manuel Valera wrote: >>>>>>>>> > > > Talked too fast, >>>>>>>>> > > > >>>>>>>>> > > > After fixing that problem, i tried more than one mpi >>>>>>>>> processor and got the following: >>>>>>>>> > > > >>>>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>>>> > > > Of sizes: 125 x 125 >>>>>>>>> > > > Matrix type: mpiaijviennacl >>>>>>>>> > > > Of sizes: 125 x 125 >>>>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>>>> -------------------------------------------------------------- >>>>>>>>> > > > [0]PETSC ERROR: No support for this operation for this >>>>>>>>> object type >>>>>>>>> > > > [0]PETSC ERROR: Currently only handles ViennaCL matrices >>>>>>>>> > > > [0]PETSC ERROR: See >>>>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>>>> shooting. >>>>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>>> > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() line 47 in >>>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu < >>>>>>>>> http://saviennacl.cu> >>>>>>>>> > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>>> > > > [1]PETSC ERROR: >>>>>>>>> ------------------------------------------------------------------------ >>>>>>>>> > > > [1]PETSC ERROR: Caught signal number 11 SEGV: Segmentation >>>>>>>>> Violation, probably memory access out of range >>>>>>>>> > > > [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] PetscTraceBackErrorHandler line 182 >>>>>>>>> /home/valera/petsc/src/sys/error/errtrace.c >>>>>>>>> > > > [1]PETSC ERROR: [1] PetscError line 352 >>>>>>>>> /home/valera/petsc/src/sys/error/err.c >>>>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp_SAVIENNACL line 45 >>>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>>>>>>> http://saviennacl.cu> >>>>>>>>> > > > >>>>>>>>> > > > [1]PETSC ERROR: [1] PCSetUp line 894 >>>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.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 Development GIT revision: >>>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>>> > > > [1]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>>>>> > > > [1]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>>> > > > [1]PETSC ERROR: #1 User provided function() line 0 in >>>>>>>>> unknown file >>>>>>>>> > > > >>>>>>>>> -------------------------------------------------------------------------- >>>>>>>>> > > > MPI_ABORT was invoked on rank 1 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. >>>>>>>>> > > > >>>>>>>>> -------------------------------------------------------------------------- >>>>>>>>> > > > [0]PETSC ERROR: >>>>>>>>> ------------------------------------------------------------------------ >>>>>>>>> > > > [0]PETSC ERROR: Caught signal number 15 Terminate: Some >>>>>>>>> process (or the batch system) has told this process to end >>>>>>>>> > > > [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. >>>>>>>>> > > > [0]PETSC ERROR: [0] PetscCommDuplicate line 130 >>>>>>>>> /home/valera/petsc/src/sys/objects/tagm.c >>>>>>>>> > > > [0]PETSC ERROR: [0] PetscHeaderCreate_Private line 34 >>>>>>>>> /home/valera/petsc/src/sys/objects/inherit.c >>>>>>>>> > > > [0]PETSC ERROR: [0] ISCreate line 35 >>>>>>>>> /home/valera/petsc/src/vec/is/is/interface/isreg.c >>>>>>>>> > > > [0]PETSC ERROR: [0] ISCreateGeneral line 668 >>>>>>>>> /home/valera/petsc/src/vec/is/is/impls/general/general.c >>>>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp_SAVIENNACL line 45 >>>>>>>>> /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/saviennacl.cu< >>>>>>>>> http://saviennacl.cu> >>>>>>>>> > > > [0]PETSC ERROR: [0] PCSetUp line 894 >>>>>>>>> /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>>> > > > [0]PETSC ERROR: --------------------- Error Message >>>>>>>>> -------------------------------------------------------------- >>>>>>>>> > > > [0]PETSC ERROR: Signal received >>>>>>>>> > > > [0]PETSC ERROR: See >>>>>>>>> http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble >>>>>>>>> shooting. >>>>>>>>> > > > [0]PETSC ERROR: Petsc Development GIT revision: >>>>>>>>> v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 +0300 >>>>>>>>> > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug named node50 by >>>>>>>>> valera Tue Aug 28 16:30:02 2018 >>>>>>>>> > > > [0]PETSC ERROR: Configure options PETSC_ARCH=cuda-debug >>>>>>>>> --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 --CXXOPTFLAGS=-O2 >>>>>>>>> --FOPTFLAGS=-O2 --with-shared-libraries=1 --with-debugging=1 --with-cuda=1 >>>>>>>>> --CUDAFLAGS=-arch=sm_60 --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>>> > > > [0]PETSC ERROR: #3 User provided function() line 0 in >>>>>>>>> unknown file >>>>>>>>> > > > [node50:30582] 1 more process has sent help message >>>>>>>>> help-mpi-api.txt / mpi-abort >>>>>>>>> > > > [node50:30582] Set MCA parameter "orte_base_help_aggregate" >>>>>>>>> to 0 to see all help / error messages >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > It is currently running in 1 mpi processor + GPU but i would >>>>>>>>> like to call at least 16 mpi processors + GPU to do the rest of the data >>>>>>>>> management who is not part of the main laplacian on the mpi and the >>>>>>>>> laplacian solution on the GPU, is this currently possible? >>>>>>>>> > > > >>>>>>>>> > > > Thanks for your help, >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > On Tue, Aug 28, 2018 at 4:21 PM, Manuel Valera < >>>>>>>>> mvalera-w at sdsu.edu > wrote: >>>>>>>>> > > > >>>>>>>>> > > > Ok, i found the culprit and we can close this thread, >>>>>>>>> > > > >>>>>>>>> > > > The problem was a missing variable for setting the >>>>>>>>> maximum columns, >>>>>>>>> > > > which i deleted at some point without realizing. The >>>>>>>>> error message >>>>>>>>> > > > was too ambiguous to catch this so i had to compare with >>>>>>>>> a previous >>>>>>>>> > > > working version of the arguments of MatSetValues, it was >>>>>>>>> evident then. >>>>>>>>> > > > >>>>>>>>> > > > Good news is that i can now set the values with the >>>>>>>>> viennacl types too, >>>>>>>>> > > > >>>>>>>>> > > > Thanks for your kind help, >>>>>>>>> > > > >>>>>>>>> > > > Manuel >>>>>>>>> > > > >>>>>>>>> > > > On Tue, Aug 28, 2018 at 11:25 AM, Smith, Barry F. >>>>>>>>> > > > > wrote: >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > 1) PetscMalloc() is never valid or needed in >>>>>>>>> Fortran >>>>>>>>> > > > >>>>>>>>> > > > 2) there is no reason to use >>>>>>>>> DMSetMatrixPreallocateOnly() >>>>>>>>> > > > just use DMCreateMatrix() assuming that using a DM >>>>>>>>> (DMDA, >>>>>>>>> > > > DMPLEX, etc) is suitable for your problem. >>>>>>>>> > > > >>>>>>>>> > > > At this end we are totally guessing at what you >>>>>>>>> are doing >>>>>>>>> > > > and so have little help we can provide. A simple, >>>>>>>>> nonworking >>>>>>>>> > > > code that tries to do what you would need would help >>>>>>>>> us a great >>>>>>>>> > > > deal in understanding that you are trying to do. >>>>>>>>> > > > >>>>>>>>> > > > Barry >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > > On Aug 28, 2018, at 1:18 PM, Manuel Valera >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > >>>>>>>>> > > > > Matthew, PetscMalloc gives the same error, >>>>>>>>> > > > > >>>>>>>>> > > > > Barry, it would be very hard for me to get the >>>>>>>>> code to a >>>>>>>>> > > > minimum working example, i guess all i need to >>>>>>>>> understand is how >>>>>>>>> > > > to setup a DM matrix with >>>>>>>>> DMSetMatrixPreallocateOnly() instead >>>>>>>>> > > > of MatMPIAIJSetPreallocation() as we were doing >>>>>>>>> before, is there >>>>>>>>> > > > a simple example who does this in Fortran? >>>>>>>>> > > > > >>>>>>>>> > > > > Is the PetscMalloc call needed? is 'call >>>>>>>>> > > > PetscMalloc(1,row,ierr)' a valid, compilable call to >>>>>>>>> > > > PetscMalloc? what other reason may there be for this >>>>>>>>> error to >>>>>>>>> > > > happen ? >>>>>>>>> > > > > >>>>>>>>> > > > > Just remembering, that trying to setup the matrix >>>>>>>>> with the >>>>>>>>> > > > MatAIJSetPreallocation() brings up an error to >>>>>>>>> acknowledge the >>>>>>>>> > > > viennacl datatypes and that's why i'm trying to make >>>>>>>>> this change >>>>>>>>> > > > on your recommendation, >>>>>>>>> > > > > >>>>>>>>> > > > > Thanks for your help, >>>>>>>>> > > > > >>>>>>>>> > > > > >>>>>>>>> > > > > >>>>>>>>> > > > > >>>>>>>>> > > > > >>>>>>>>> > > > > On Mon, Aug 27, 2018 at 7:35 PM, Smith, Barry F. >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > >>>>>>>>> > > > > Send your code in a way we can compile and run >>>>>>>>> it; it must >>>>>>>>> > > > be some simple issue that is hard to communicate in >>>>>>>>> email. >>>>>>>>> > > > > >>>>>>>>> > > > > Barry >>>>>>>>> > > > > >>>>>>>>> > > > > >>>>>>>>> > > > > > On Aug 27, 2018, at 5:51 PM, Manuel Valera >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > >>>>>>>>> > > > > > Hello everyone, >>>>>>>>> > > > > > >>>>>>>>> > > > > > I just had time to work on this again, and >>>>>>>>> checked the code >>>>>>>>> > > > for errors on the matrix entries, this is the exact >>>>>>>>> code i was >>>>>>>>> > > > using for creating the matrix without >>>>>>>>> > > > DMSetMatrixPreallocateOnly, using >>>>>>>>> MatMPIAIJSetPreallocation and >>>>>>>>> > > > it worked that way, but trying this way i get the >>>>>>>>> same 'Column >>>>>>>>> > > > too large' error using any number at the column >>>>>>>>> position of >>>>>>>>> > > > MatSetValues, >>>>>>>>> > > > > > >>>>>>>>> > > > > > I have set up my code to print the column >>>>>>>>> argument (n) of >>>>>>>>> > > > MatSetValues and in this case is 7 (lower than 124), >>>>>>>>> it still >>>>>>>>> > > > gives error, even entering a specific number in the >>>>>>>>> MatSetValues >>>>>>>>> > > > column argument position gives the same error. >>>>>>>>> > > > > > >>>>>>>>> > > > > > So next i went back to ex.50 here: >>>>>>>>> > > > >>>>>>>>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html >>>>>>>>> > > > < >>>>>>>>> http://www.mcs.anl.gov/petsc/petsc-current/src/ts/examples/tutorials/ex50.c.html >>>>>>>>> > >>>>>>>>> > > > and it has a very similar structure except the >>>>>>>>> PetscMalloc1() >>>>>>>>> > > > call, so i tried adding that and got: >>>>>>>>> > > > > > >>>>>>>>> > > > > > >>>>>>>>> /home/valera/ParGCCOM/Src/DMDALaplacian.f90:114: undefined >>>>>>>>> > > > reference to `petscmalloc1_' >>>>>>>>> > > > > > >>>>>>>>> > > > > > Any ideas on this behaviour? >>>>>>>>> > > > > > >>>>>>>>> > > > > > Thanks so much, >>>>>>>>> > > > > > >>>>>>>>> > > > > > >>>>>>>>> > > > > > >>>>>>>>> > > > > > >>>>>>>>> > > > > > >>>>>>>>> > > > > > >>>>>>>>> > > > > > On Thu, Aug 16, 2018 at 11:20 AM, Smith, Barry >>>>>>>>> F. >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > >>>>>>>>> > > > > > Column too large: col 10980 max 124 >>>>>>>>> > > > > > >>>>>>>>> > > > > > You need to check the code that is >>>>>>>>> generating the matrix >>>>>>>>> > > > entries. The matrix has 124 columns but you are >>>>>>>>> attempting to >>>>>>>>> > > > put a value at column 10980 >>>>>>>>> > > > > > >>>>>>>>> > > > > > Barry >>>>>>>>> > > > > > >>>>>>>>> > > > > > >>>>>>>>> > > > > > > On Aug 15, 2018, at 9:44 PM, Manuel Valera >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > Thanks Matthew and Barry, >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > Now my code looks like: >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > call >>>>>>>>> DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>>>>>>>> > > > > > > call >>>>>>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>>>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>>>> > > > > > > call MatSetFromOptions(A,ierr) >>>>>>>>> > > > > > > call MatSetUp(A,ierr) >>>>>>>>> > > > > > > [...] >>>>>>>>> > > > > > > call >>>>>>>>> > > > >>>>>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>>>> > > > > > > [...] >>>>>>>>> > > > > > > call MatAssemblyBegin(A, MAT_FINAL_ASSEMBLY, >>>>>>>>> ierr) >>>>>>>>> > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, >>>>>>>>> ierr) >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > And i get a different error, now is: >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > [0]PETSC ERROR: --------------------- Error >>>>>>>>> Message >>>>>>>>> > > > >>>>>>>>> -------------------------------------------------------------- >>>>>>>>> > > > > > > [0]PETSC ERROR: Argument out of range >>>>>>>>> > > > > > > [0]PETSC ERROR: Column too large: col 10980 >>>>>>>>> max 124 >>>>>>>>> > > > > > > [0]PETSC ERROR: See >>>>>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>>>>> > > > >>>>>>>>> for >>>>>>>>> > > > trouble shooting. >>>>>>>>> > > > > > > [0]PETSC ERROR: Petsc Development GIT >>>>>>>>> revision: >>>>>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 >>>>>>>>> +0300 >>>>>>>>> > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a cuda-debug >>>>>>>>> named node50 >>>>>>>>> > > > by valera Wed Aug 15 19:40:00 2018 >>>>>>>>> > > > > > > [0]PETSC ERROR: Configure options >>>>>>>>> PETSC_ARCH=cuda-debug >>>>>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>>>>> --with-shared-libraries=1 >>>>>>>>> > > > --with-debugging=1 --with-cuda=1 >>>>>>>>> --CUDAFLAGS=-arch=sm_60 >>>>>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>>> > > > > > > [0]PETSC ERROR: #1 MatSetValues_SeqAIJ() line >>>>>>>>> 442 in >>>>>>>>> > > > /home/valera/petsc/src/mat/impls/aij/seq/aij.c >>>>>>>>> > > > > > > [0]PETSC ERROR: #2 MatSetValues() line 1339 in >>>>>>>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > Thanks again, >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > On Wed, Aug 15, 2018 at 7:02 PM, Smith, Barry >>>>>>>>> F. >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > Should be >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > call >>>>>>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>>>>> > > > > > > call DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>>>> > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > and remove the rest. You need to set the >>>>>>>>> type of Mat >>>>>>>>> > > > you want the DM to return BEFORE you create the >>>>>>>>> matrix. >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > Barry >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > > On Aug 15, 2018, at 4:45 PM, Manuel Valera >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Ok thanks for clarifying that, i wasn't >>>>>>>>> sure if there >>>>>>>>> > > > were different types, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Here is a stripped down version of my code, >>>>>>>>> it seems >>>>>>>>> > > > like the preallocation is working now since the >>>>>>>>> matrix >>>>>>>>> > > > population part is working without problem, but here >>>>>>>>> it is for >>>>>>>>> > > > illustration purposes: >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > call >>>>>>>>> DMSetMatrixPreallocateOnly(daDummy,PETSC_TRUE,ierr) >>>>>>>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>>>>>>> > > > > > > > call >>>>>>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>>>>> > > > > > > > call >>>>>>>>> DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>>>> > > > > > > > call >>>>>>>>> > > > >>>>>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>>>>> > > > > > > > call MatSetUp(A,ierr) >>>>>>>>> > > > > > > > [...] >>>>>>>>> > > > > > > > call >>>>>>>>> > > > >>>>>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>>>> > > > > > > > [...] >>>>>>>>> > > > > > > > call MatAssemblyBegin(A, >>>>>>>>> MAT_FINAL_ASSEMBLY, ierr) >>>>>>>>> > > > > > > > call MatAssemblyEnd(A, MAT_FINAL_ASSEMBLY, >>>>>>>>> ierr) >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Adding the first line there did the trick, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Now the problem seems to be the program is >>>>>>>>> not >>>>>>>>> > > > recognizing the matrix as ViennaCL type when i try >>>>>>>>> with more >>>>>>>>> > > > than one processor, i get now: >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > [0]PETSC ERROR: --------------------- Error >>>>>>>>> Message >>>>>>>>> > > > >>>>>>>>> -------------------------------------------------------------- >>>>>>>>> > > > > > > > [0]PETSC ERROR: No support for this >>>>>>>>> operation for this >>>>>>>>> > > > object type >>>>>>>>> > > > > > > > [0]PETSC ERROR: Currently only handles >>>>>>>>> ViennaCL matrices >>>>>>>>> > > > > > > > [0]PETSC ERROR: See >>>>>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>>>>> > > > >>>>>>>>> for >>>>>>>>> > > > trouble shooting. >>>>>>>>> > > > > > > > [0]PETSC ERROR: Petsc Development GIT >>>>>>>>> revision: >>>>>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 >>>>>>>>> +0300 >>>>>>>>> > > > > > > > [0]PETSC ERROR: ./gcmLEP.GPU on a >>>>>>>>> cuda-debug named >>>>>>>>> > > > node50 by valera Wed Aug 15 14:44:22 2018 >>>>>>>>> > > > > > > > [0]PETSC ERROR: Configure options >>>>>>>>> PETSC_ARCH=cuda-debug >>>>>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>>>>> --with-shared-libraries=1 >>>>>>>>> > > > --with-debugging=1 --with-cuda=1 >>>>>>>>> --CUDAFLAGS=-arch=sm_60 >>>>>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>>> > > > > > > > [0]PETSC ERROR: #1 PCSetUp_SAVIENNACL() >>>>>>>>> line 47 in >>>>>>>>> > > > /home/valera/petsc/src/ksp/pc/impls/saviennaclcuda/ >>>>>>>>> saviennacl.cu >>>>>>>>> > > > >>>>>>>>> > > > > > > > [0]PETSC ERROR: #2 PCSetUp() line 932 in >>>>>>>>> > > > /home/valera/petsc/src/ksp/pc/interface/precon.c >>>>>>>>> > > > > > > > [0]PETSC ERROR: #3 KSPSetUp() line 381 in >>>>>>>>> > > > /home/valera/petsc/src/ksp/ksp/interface/itfunc.c >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > When running with: >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > mpirun -n 1 ./gcmLEP.GPU >>>>>>>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ >>>>>>>>> jid=tiny_cuda_test_n2 >>>>>>>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>>>>>> aijviennacl >>>>>>>>> > > > -pc_type saviennacl -log_view >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Thanks, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 2:32 PM, Matthew >>>>>>>>> Knepley >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 5:20 PM Manuel >>>>>>>>> Valera >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > > > It seems to be resumed on: I do not know >>>>>>>>> how to >>>>>>>>> > > > preallocate a DM Matrix correctly. >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > There is only one matrix type, Mat. There >>>>>>>>> are no >>>>>>>>> > > > separate DM matrices. A DM can create a matrix for >>>>>>>>> you >>>>>>>>> > > > > > > > using DMCreateMatrix(), but that is a Mat >>>>>>>>> and it is >>>>>>>>> > > > preallocated correctly. I am not sure what you are >>>>>>>>> doing. >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Thanks, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Matt >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > The interesting part is that it only breaks >>>>>>>>> when i need >>>>>>>>> > > > to populate a GPU matrix from MPI, so kudos on that, >>>>>>>>> but it >>>>>>>>> > > > seems i need to do better on my code to get this >>>>>>>>> setup working, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Any help would be appreciated, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Thanks, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 2:15 PM, Matthew >>>>>>>>> Knepley >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 4:53 PM Manuel >>>>>>>>> Valera >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > > > Thanks Matthew, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > I try to do that when calling: >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > call >>>>>>>>> > > > >>>>>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > But i am not aware on how to do this for >>>>>>>>> the DM if it >>>>>>>>> > > > needs something more specific/different, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > The error says that your preallocation is >>>>>>>>> wrong for the >>>>>>>>> > > > values you are putting in. The DM does not control >>>>>>>>> either, >>>>>>>>> > > > > > > > so I do not understand your email. >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Thanks, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Matt >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Thanks, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 1:51 PM, Matthew >>>>>>>>> Knepley >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > > > On Wed, Aug 15, 2018 at 4:39 PM Manuel >>>>>>>>> Valera >>>>>>>>> > > > > >>>>>>>>> wrote: >>>>>>>>> > > > > > > > Hello PETSc devs, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > I am running into an error when trying to >>>>>>>>> use the >>>>>>>>> > > > MATMPIAIJVIENNACL Matrix type in MPI calls, the same >>>>>>>>> code runs >>>>>>>>> > > > for MATSEQAIJVIENNACL type in one processor. The >>>>>>>>> error happens >>>>>>>>> > > > when calling MatSetValues for this specific >>>>>>>>> configuration. It >>>>>>>>> > > > does not occur when using MPI DMMatrix types only. >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > The DM properly preallocates the matrix. I >>>>>>>>> am assuming >>>>>>>>> > > > you do not here. >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Matt >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Any help will be appreciated, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > Thanks, >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > My program call: >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > mpirun -n 2 ./gcmLEP.GPU >>>>>>>>> > > > tc=TestCases/LockRelease/LE_6x6x6/ >>>>>>>>> jid=tiny_cuda_test_n2 >>>>>>>>> > > > -ksp_type cg -dm_vec_type viennacl -dm_mat_type >>>>>>>>> aijviennacl >>>>>>>>> > > > -pc_type saviennacl -log_view >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > The error (repeats after each MatSetValues >>>>>>>>> call): >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > [1]PETSC ERROR: --------------------- Error >>>>>>>>> Message >>>>>>>>> > > > >>>>>>>>> -------------------------------------------------------------- >>>>>>>>> > > > > > > > [1]PETSC ERROR: Argument out of range >>>>>>>>> > > > > > > > [1]PETSC ERROR: Inserting a new nonzero at >>>>>>>>> global >>>>>>>>> > > > row/column (75, 50) into matrix >>>>>>>>> > > > > > > > [1]PETSC ERROR: See >>>>>>>>> > > > http://www.mcs.anl.gov/petsc/documentation/faq.html >>>>>>>>> > > > >>>>>>>>> for >>>>>>>>> > > > trouble shooting. >>>>>>>>> > > > > > > > [1]PETSC ERROR: Petsc Development GIT >>>>>>>>> revision: >>>>>>>>> > > > v3.9.2-549-g779ab53 GIT Date: 2018-05-31 17:31:13 >>>>>>>>> +0300 >>>>>>>>> > > > > > > > [1]PETSC ERROR: ./gcmLEP.GPU on a >>>>>>>>> cuda-debug named >>>>>>>>> > > > node50 by valera Wed Aug 15 13:10:44 2018 >>>>>>>>> > > > > > > > [1]PETSC ERROR: Configure options >>>>>>>>> PETSC_ARCH=cuda-debug >>>>>>>>> > > > --with-mpi-dir=/usr/lib64/openmpi --COPTFLAGS=-O2 >>>>>>>>> > > > --CXXOPTFLAGS=-O2 --FOPTFLAGS=-O2 >>>>>>>>> --with-shared-libraries=1 >>>>>>>>> > > > --with-debugging=1 --with-cuda=1 >>>>>>>>> --CUDAFLAGS=-arch=sm_60 >>>>>>>>> > > > --with-blaslapack-dir=/usr/lib64 --download-viennacl >>>>>>>>> > > > > > > > [1]PETSC ERROR: #1 MatSetValues_MPIAIJ() >>>>>>>>> line 608 in >>>>>>>>> > > > /home/valera/petsc/src/mat/impls/aij/mpi/mpiaij.c >>>>>>>>> > > > > > > > [1]PETSC ERROR: #2 MatSetValues() line 1339 >>>>>>>>> in >>>>>>>>> > > > /home/valera/petsc/src/mat/interface/matrix.c >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > My Code structure: >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > call DMCreateMatrix(daDummy,A,ierr) >>>>>>>>> > > > > > > > call MatSetFromOptions(A,ierr) >>>>>>>>> > > > > > > > call MPI_Comm_size(PETSC_COMM_WORLD, >>>>>>>>> numprocs, ierr) >>>>>>>>> > > > > > > > if (numprocs > 1) then ! set matrix type >>>>>>>>> parallel >>>>>>>>> > > > > > > > ! Get local size >>>>>>>>> > > > > > > > call >>>>>>>>> DMDACreateNaturalVector(daDummy,Tmpnat,ierr) >>>>>>>>> > > > > > > > call >>>>>>>>> VecGetLocalSize(Tmpnat,locsize,ierr) >>>>>>>>> > > > > > > > call VecDestroy(Tmpnat,ierr) >>>>>>>>> > > > > > > > ! Set matrix >>>>>>>>> > > > > > > > #ifdef GPU >>>>>>>>> > > > > > > > call MatSetType(A,MATAIJVIENNACL,ierr) >>>>>>>>> > > > > > > > call >>>>>>>>> DMSetMatType(daDummy,MATMPIAIJVIENNACL,ierr) >>>>>>>>> > > > > > > > call >>>>>>>>> DMSetVecType(daDummy,VECMPIVIENNACL,ierr) >>>>>>>>> > > > > > > > print*,'SETTING GPU TYPES' >>>>>>>>> > > > > > > > #else >>>>>>>>> > > > > > > > call >>>>>>>>> DMSetMatType(daDummy,MATMPIAIJ,ierr) >>>>>>>>> > > > > > > > call DMSetMatType(daDummy,VECMPI,ierr) >>>>>>>>> > > > > > > > call MatSetType(A,MATMPIAIJ,ierr)! >>>>>>>>> > > > > > > > #endif >>>>>>>>> > > > > > > > call >>>>>>>>> > > > >>>>>>>>> MatMPIAIJSetPreallocation(A,19,PETSC_NULL_INTEGER,19,PETSC_NULL_INTEGER,ierr) >>>>>>>>> > > > > > > > else ! set matrix type >>>>>>>>> sequential >>>>>>>>> > > > > > > > #ifdef GPU >>>>>>>>> > > > > > > > call >>>>>>>>> DMSetMatType(daDummy,MATSEQAIJVIENNACL,ierr) >>>>>>>>> > > > > > > > call >>>>>>>>> DMSetVecType(daDummy,VECSEQVIENNACL,ierr) >>>>>>>>> > > > > > > > call >>>>>>>>> MatSetType(A,MATSEQAIJVIENNACL,ierr) >>>>>>>>> > > > > > > > print*,'SETTING GPU TYPES' >>>>>>>>> > > > > > > > #else >>>>>>>>> > > > > > > > call >>>>>>>>> DMSetMatType(daDummy,MATSEQAIJ,ierr) >>>>>>>>> > > > > > > > call DMSetMatType(daDummy,VECSEQ,ierr) >>>>>>>>> > > > > > > > call MatSetType(A,MATSEQAIJ,ierr) >>>>>>>>> > > > > > > > #endif >>>>>>>>> > > > > > > > call MatSetUp(A,ierr) >>>>>>>>> > > > > > > > call >>>>>>>>> > > > >>>>>>>>> getCenterInfo(daGrid,xstart,ystart,zstart,xend,yend,zend) >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > do k=zstart,zend-1 >>>>>>>>> > > > > > > > do j=ystart,yend-1 >>>>>>>>> > > > > > > > do i=xstart,xend-1 >>>>>>>>> > > > > > > > [..] >>>>>>>>> > > > > > > > call >>>>>>>>> > > > >>>>>>>>> MatSetValues(A,1,row,sumpos,pos(0:iter-1),vals(0:iter-1),INSERT_VALUES,ierr) >>>>>>>>> > > > > > > > [..] >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > -- >>>>>>>>> > > > > > > > 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 >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>>>>> > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > -- >>>>>>>>> > > > > > > > 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 >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>>>>> > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > -- >>>>>>>>> > > > > > > > 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 >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > > https://www.cse.buffalo.edu/~knepley/ >>>>>>>>> > > > >>>>>>>>> > > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > > >>>>>>>>> > > > > > >>>>>>>>> > > > > > >>>>>>>>> > > > > >>>>>>>>> > > > > >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > > > >>>>>>>>> > >>>>>>>>> > >>>>>>>>> > >>>>>>>>> >>>>>>>>> >>>>>>>> >>>>>>> >>>>>> >>>>>> -- >>>>>> 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 >>>>>> >>>>>> https://www.cse.buffalo.edu/~knepley/ >>>>>> >>>>>> >>>>> >>>>> >>>> >>>> -- >>>> 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 >>>> >>>> https://www.cse.buffalo.edu/~knepley/ >>>> >>>> >>> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ >> >> > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From zonexo at gmail.com Thu Aug 30 21:17:12 2018 From: zonexo at gmail.com (TAY wee-beng) Date: Fri, 31 Aug 2018 10:17:12 +0800 Subject: [petsc-users] Problem compiling with 64bit PETSc Message-ID: Hi, Due to my increase grid size, I have to go 64bit. I compiled the 64bit PETSc w/o error. However, when I tried to compile my code using the 64bit PETSc, I got the error below. May I know why is this so? What changes should I make? [tsltaywb at nus02 ibm3d_IIB_mpi]$ make -f makefile_2018 /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 -g -ip -ipo -O3 -c -fPIC? -save kinefunc.F90 /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 -g -ip -ipo -O3 -c -fPIC? -save? -w -I/home/users/nus/tsltaywb/propeller/lib/petsc-3.9.3_intel_2018_64bit_rel/include -I/app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/include global.F90 global.F90(979): error #6285: There is no matching specific subroutine for this generic subroutine call.?? [DMDACREATE3D] call DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& -----^ global.F90(989): error #6285: There is no matching specific subroutine for this generic subroutine call.?? [DMDACREATE3D] ??? call DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& ---------^ global.F90(997): error #6285: There is no matching specific subroutine for this generic subroutine call.?? [DMDACREATE3D] ??? call DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& ---------^ global.F90(1005): error #6285: There is no matching specific subroutine for this generic subroutine call.?? [DMDACREATE3D] ??? call DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& ---------^ global.F90(1013): error #6285: There is no matching specific subroutine for this generic subroutine call.?? [DMDACREATE3D] ??? call DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& ---------^ global.F90(1021): error #6285: There is no matching specific subroutine for this generic subroutine call.?? [DMDACREATE3D] ??? call DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& ---------^ global.F90(1029): error #6285: There is no matching specific subroutine for this generic subroutine call.?? [DMDACREATE3D] ??? call DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& ---------^ compilation aborted for global.F90 (code 1) -- Thank you very much. Yours sincerely, ================================================ TAY Wee-Beng (Zheng Weiming) ??? Personal research webpage: http://tayweebeng.wixsite.com/website Youtube research showcase: https://www.youtube.com/channel/UC72ZHtvQNMpNs2uRTSToiLA linkedin: www.linkedin.com/in/tay-weebeng ================================================ From knepley at gmail.com Thu Aug 30 21:21:49 2018 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 30 Aug 2018 22:21:49 -0400 Subject: [petsc-users] Problem compiling with 64bit PETSc In-Reply-To: References: Message-ID: On Thu, Aug 30, 2018 at 10:17 PM TAY wee-beng wrote: > Hi, > > Due to my increase grid size, I have to go 64bit. I compiled the 64bit > PETSc w/o error. However, when I tried to compile my code using the > 64bit PETSc, I got the error below. May I know why is this so? > > What changes should I make? > Is it possible that you did not declare some inputs as PetscInt, so the interface check is failing? Matt > > [tsltaywb at nus02 ibm3d_IIB_mpi]$ make -f makefile_2018 > /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 > > -g -ip -ipo -O3 -c -fPIC -save kinefunc.F90 > /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 > > -g -ip -ipo -O3 -c -fPIC -save -w > -I/home/users/nus/tsltaywb/propeller/lib/petsc-3.9.3_intel_2018_64bit_rel/include > > -I/app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/include > > global.F90 > global.F90(979): error #6285: There is no matching specific subroutine > for this generic subroutine call. [DMDACREATE3D] > call > > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > -----^ > global.F90(989): error #6285: There is no matching specific subroutine > for this generic subroutine call. [DMDACREATE3D] > call > > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > global.F90(997): error #6285: There is no matching specific subroutine > for this generic subroutine call. [DMDACREATE3D] > call > > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > global.F90(1005): error #6285: There is no matching specific subroutine > for this generic subroutine call. [DMDACREATE3D] > call > > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > global.F90(1013): error #6285: There is no matching specific subroutine > for this generic subroutine call. [DMDACREATE3D] > call > > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > global.F90(1021): error #6285: There is no matching specific subroutine > for this generic subroutine call. [DMDACREATE3D] > call > > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > global.F90(1029): error #6285: There is no matching specific subroutine > for this generic subroutine call. [DMDACREATE3D] > call > > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > compilation aborted for global.F90 (code 1) > > -- > Thank you very much. > > Yours sincerely, > > ================================================ > TAY Wee-Beng (Zheng Weiming) ??? > Personal research webpage: http://tayweebeng.wixsite.com/website > Youtube research showcase: > https://www.youtube.com/channel/UC72ZHtvQNMpNs2uRTSToiLA > linkedin: www.linkedin.com/in/tay-weebeng > ================================================ > > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From zonexo at gmail.com Thu Aug 30 21:35:05 2018 From: zonexo at gmail.com (TAY wee-beng) Date: Fri, 31 Aug 2018 10:35:05 +0800 Subject: [petsc-users] Problem compiling with 64bit PETSc In-Reply-To: References: Message-ID: On 31/8/2018 10:21 AM, Matthew Knepley wrote: > On Thu, Aug 30, 2018 at 10:17 PM TAY wee-beng > wrote: > > Hi, > > Due to my increase grid size, I have to go 64bit. I compiled the > 64bit > PETSc w/o error. However, when I tried to compile my code using the > 64bit PETSc, I got the error below. May I know why is this so? > > What changes should I make? > > > Is it possible that you did not declare some inputs as PetscInt, so > the interface check is failing? > > ? ?Matt Hi, I'm using the standard integer :: real(8) :: for some variables. For some others relating to PETSc, I use PetscInt. Should I change all to PetscInt and PetscReal? Currently, I use real(8) for all real values. If I change all to PetscReal, will PetscReal be real or real(8) by default? Thanks! > > > [tsltaywb at nus02 ibm3d_IIB_mpi]$ make -f makefile_2018 > /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 > > -g -ip -ipo -O3 -c -fPIC? -save kinefunc.F90 > /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 > > -g -ip -ipo -O3 -c -fPIC? -save? -w > -I/home/users/nus/tsltaywb/propeller/lib/petsc-3.9.3_intel_2018_64bit_rel/include > > -I/app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/include > > global.F90 > global.F90(979): error #6285: There is no matching specific > subroutine > for this generic subroutine call.?? [DMDACREATE3D] > call > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > -----^ > global.F90(989): error #6285: There is no matching specific > subroutine > for this generic subroutine call.?? [DMDACREATE3D] > ???? call > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > global.F90(997): error #6285: There is no matching specific > subroutine > for this generic subroutine call.?? [DMDACREATE3D] > ???? call > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > global.F90(1005): error #6285: There is no matching specific > subroutine > for this generic subroutine call.?? [DMDACREATE3D] > ???? call > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > global.F90(1013): error #6285: There is no matching specific > subroutine > for this generic subroutine call.?? [DMDACREATE3D] > ???? call > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > global.F90(1021): error #6285: There is no matching specific > subroutine > for this generic subroutine call.?? [DMDACREATE3D] > ???? call > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > global.F90(1029): error #6285: There is no matching specific > subroutine > for this generic subroutine call.?? [DMDACREATE3D] > ???? call > DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& > ---------^ > compilation aborted for global.F90 (code 1) > > -- > Thank you very much. > > Yours sincerely, > > ================================================ > TAY Wee-Beng (Zheng Weiming) ??? > Personal research webpage: http://tayweebeng.wixsite.com/website > Youtube research showcase: > https://www.youtube.com/channel/UC72ZHtvQNMpNs2uRTSToiLA > linkedin: www.linkedin.com/in/tay-weebeng > > ================================================ > > > > -- > 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 > > https://www.cse.buffalo.edu/~knepley/ > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Aug 30 21:38:36 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Fri, 31 Aug 2018 02:38:36 +0000 Subject: [petsc-users] Problem compiling with 64bit PETSc In-Reply-To: References: Message-ID: <2C69D0C3-5D83-4AD5-9B54-783A746DF0D9@anl.gov> PetscReal is by default real(8) you can leave those alone Any integer you pass to a PETSc routine needs to be declared as PetscInt (not integer) otherwise the 64 bit indices stuff won't work. Barry > On Aug 30, 2018, at 9:35 PM, TAY wee-beng wrote: > > > On 31/8/2018 10:21 AM, Matthew Knepley wrote: >> On Thu, Aug 30, 2018 at 10:17 PM TAY wee-beng wrote: >> Hi, >> >> Due to my increase grid size, I have to go 64bit. I compiled the 64bit >> PETSc w/o error. However, when I tried to compile my code using the >> 64bit PETSc, I got the error below. May I know why is this so? >> >> What changes should I make? >> >> Is it possible that you did not declare some inputs as PetscInt, so the interface check is failing? >> >> Matt > Hi, > > I'm using the standard > > integer :: > > real(8) :: > > for some variables. For some others relating to PETSc, I use PetscInt. > > Should I change all to PetscInt and PetscReal? > > Currently, I use real(8) for all real values. If I change all to PetscReal, will PetscReal be real or real(8) by default? > > Thanks! >> >> >> [tsltaywb at nus02 ibm3d_IIB_mpi]$ make -f makefile_2018 >> /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 >> -g -ip -ipo -O3 -c -fPIC -save kinefunc.F90 >> /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 >> -g -ip -ipo -O3 -c -fPIC -save -w >> -I/home/users/nus/tsltaywb/propeller/lib/petsc-3.9.3_intel_2018_64bit_rel/include >> -I/app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/include >> global.F90 >> global.F90(979): error #6285: There is no matching specific subroutine >> for this generic subroutine call. [DMDACREATE3D] >> call >> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >> -----^ >> global.F90(989): error #6285: There is no matching specific subroutine >> for this generic subroutine call. [DMDACREATE3D] >> call >> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >> ---------^ >> global.F90(997): error #6285: There is no matching specific subroutine >> for this generic subroutine call. [DMDACREATE3D] >> call >> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >> ---------^ >> global.F90(1005): error #6285: There is no matching specific subroutine >> for this generic subroutine call. [DMDACREATE3D] >> call >> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >> ---------^ >> global.F90(1013): error #6285: There is no matching specific subroutine >> for this generic subroutine call. [DMDACREATE3D] >> call >> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >> ---------^ >> global.F90(1021): error #6285: There is no matching specific subroutine >> for this generic subroutine call. [DMDACREATE3D] >> call >> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >> ---------^ >> global.F90(1029): error #6285: There is no matching specific subroutine >> for this generic subroutine call. [DMDACREATE3D] >> call >> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >> ---------^ >> compilation aborted for global.F90 (code 1) >> >> -- >> Thank you very much. >> >> Yours sincerely, >> >> ================================================ >> TAY Wee-Beng (Zheng Weiming) ??? >> Personal research webpage: http://tayweebeng.wixsite.com/website >> Youtube research showcase: https://www.youtube.com/channel/UC72ZHtvQNMpNs2uRTSToiLA >> linkedin: www.linkedin.com/in/tay-weebeng >> ================================================ >> >> >> >> -- >> 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 >> >> https://www.cse.buffalo.edu/~knepley/ > From zonexo at gmail.com Thu Aug 30 21:40:51 2018 From: zonexo at gmail.com (TAY wee-beng) Date: Fri, 31 Aug 2018 10:40:51 +0800 Subject: [petsc-users] Problem compiling with 64bit PETSc In-Reply-To: <2C69D0C3-5D83-4AD5-9B54-783A746DF0D9@anl.gov> References: <2C69D0C3-5D83-4AD5-9B54-783A746DF0D9@anl.gov> Message-ID: <27433b40-13a9-0b4c-18b1-141b251c068f@gmail.com> On 31/8/2018 10:38 AM, Smith, Barry F. wrote: > PetscReal is by default real(8) you can leave those alone > > Any integer you pass to a PETSc routine needs to be declared as PetscInt (not integer) otherwise the 64 bit indices stuff won't work. > > Barry > Hi, ok, I got it. Btw, is it advisable to change all integer in my code to PetscInt? Will it cause any conflict or waste a lot of memory? Or should I only change those related to PETSc? Thanks! >> On Aug 30, 2018, at 9:35 PM, TAY wee-beng wrote: >> >> >> On 31/8/2018 10:21 AM, Matthew Knepley wrote: >>> On Thu, Aug 30, 2018 at 10:17 PM TAY wee-beng wrote: >>> Hi, >>> >>> Due to my increase grid size, I have to go 64bit. I compiled the 64bit >>> PETSc w/o error. However, when I tried to compile my code using the >>> 64bit PETSc, I got the error below. May I know why is this so? >>> >>> What changes should I make? >>> >>> Is it possible that you did not declare some inputs as PetscInt, so the interface check is failing? >>> >>> Matt >> Hi, >> >> I'm using the standard >> >> integer :: >> >> real(8) :: >> >> for some variables. For some others relating to PETSc, I use PetscInt. >> >> Should I change all to PetscInt and PetscReal? >> >> Currently, I use real(8) for all real values. If I change all to PetscReal, will PetscReal be real or real(8) by default? >> >> Thanks! >>> >>> >>> [tsltaywb at nus02 ibm3d_IIB_mpi]$ make -f makefile_2018 >>> /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 >>> -g -ip -ipo -O3 -c -fPIC -save kinefunc.F90 >>> /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 >>> -g -ip -ipo -O3 -c -fPIC -save -w >>> -I/home/users/nus/tsltaywb/propeller/lib/petsc-3.9.3_intel_2018_64bit_rel/include >>> -I/app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/include >>> global.F90 >>> global.F90(979): error #6285: There is no matching specific subroutine >>> for this generic subroutine call. [DMDACREATE3D] >>> call >>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>> -----^ >>> global.F90(989): error #6285: There is no matching specific subroutine >>> for this generic subroutine call. [DMDACREATE3D] >>> call >>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>> ---------^ >>> global.F90(997): error #6285: There is no matching specific subroutine >>> for this generic subroutine call. [DMDACREATE3D] >>> call >>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>> ---------^ >>> global.F90(1005): error #6285: There is no matching specific subroutine >>> for this generic subroutine call. [DMDACREATE3D] >>> call >>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>> ---------^ >>> global.F90(1013): error #6285: There is no matching specific subroutine >>> for this generic subroutine call. [DMDACREATE3D] >>> call >>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>> ---------^ >>> global.F90(1021): error #6285: There is no matching specific subroutine >>> for this generic subroutine call. [DMDACREATE3D] >>> call >>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>> ---------^ >>> global.F90(1029): error #6285: There is no matching specific subroutine >>> for this generic subroutine call. [DMDACREATE3D] >>> call >>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>> ---------^ >>> compilation aborted for global.F90 (code 1) >>> >>> -- >>> Thank you very much. >>> >>> Yours sincerely, >>> >>> ================================================ >>> TAY Wee-Beng (Zheng Weiming) ??? >>> Personal research webpage: http://tayweebeng.wixsite.com/website >>> Youtube research showcase: https://www.youtube.com/channel/UC72ZHtvQNMpNs2uRTSToiLA >>> linkedin: www.linkedin.com/in/tay-weebeng >>> ================================================ >>> >>> >>> >>> -- >>> 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 >>> >>> https://www.cse.buffalo.edu/~knepley/ From bsmith at mcs.anl.gov Thu Aug 30 21:43:05 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Fri, 31 Aug 2018 02:43:05 +0000 Subject: [petsc-users] Problem compiling with 64bit PETSc In-Reply-To: <27433b40-13a9-0b4c-18b1-141b251c068f@gmail.com> References: <2C69D0C3-5D83-4AD5-9B54-783A746DF0D9@anl.gov> <27433b40-13a9-0b4c-18b1-141b251c068f@gmail.com> Message-ID: <14BE4673-3EE5-48AC-96F1-288FCDA6517D@mcs.anl.gov> > On Aug 30, 2018, at 9:40 PM, TAY wee-beng wrote: > > > On 31/8/2018 10:38 AM, Smith, Barry F. wrote: >> PetscReal is by default real(8) you can leave those alone >> >> Any integer you pass to a PETSc routine needs to be declared as PetscInt (not integer) otherwise the 64 bit indices stuff won't work. >> >> Barry >> > Hi, > > ok, I got it. Btw, is it advisable to change all integer in my code to PetscInt? > > Will it cause any conflict or waste a lot of memory? > > Or should I only change those related to PETSc? That is up to you. Since you probably pass the values between PETSc and non-PETSc part of the code it is probably easier just to make all the integer PetscInt instead. No performance difference that you can measure by keeping a few integer around. Barry > > Thanks! >>> On Aug 30, 2018, at 9:35 PM, TAY wee-beng wrote: >>> >>> >>> On 31/8/2018 10:21 AM, Matthew Knepley wrote: >>>> On Thu, Aug 30, 2018 at 10:17 PM TAY wee-beng wrote: >>>> Hi, >>>> >>>> Due to my increase grid size, I have to go 64bit. I compiled the 64bit >>>> PETSc w/o error. However, when I tried to compile my code using the >>>> 64bit PETSc, I got the error below. May I know why is this so? >>>> >>>> What changes should I make? >>>> >>>> Is it possible that you did not declare some inputs as PetscInt, so the interface check is failing? >>>> >>>> Matt >>> Hi, >>> >>> I'm using the standard >>> >>> integer :: >>> >>> real(8) :: >>> >>> for some variables. For some others relating to PETSc, I use PetscInt. >>> >>> Should I change all to PetscInt and PetscReal? >>> >>> Currently, I use real(8) for all real values. If I change all to PetscReal, will PetscReal be real or real(8) by default? >>> >>> Thanks! >>>> >>>> [tsltaywb at nus02 ibm3d_IIB_mpi]$ make -f makefile_2018 >>>> /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 >>>> -g -ip -ipo -O3 -c -fPIC -save kinefunc.F90 >>>> /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 >>>> -g -ip -ipo -O3 -c -fPIC -save -w >>>> -I/home/users/nus/tsltaywb/propeller/lib/petsc-3.9.3_intel_2018_64bit_rel/include >>>> -I/app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/include >>>> global.F90 >>>> global.F90(979): error #6285: There is no matching specific subroutine >>>> for this generic subroutine call. [DMDACREATE3D] >>>> call >>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>> -----^ >>>> global.F90(989): error #6285: There is no matching specific subroutine >>>> for this generic subroutine call. [DMDACREATE3D] >>>> call >>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>> ---------^ >>>> global.F90(997): error #6285: There is no matching specific subroutine >>>> for this generic subroutine call. [DMDACREATE3D] >>>> call >>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>> ---------^ >>>> global.F90(1005): error #6285: There is no matching specific subroutine >>>> for this generic subroutine call. [DMDACREATE3D] >>>> call >>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>> ---------^ >>>> global.F90(1013): error #6285: There is no matching specific subroutine >>>> for this generic subroutine call. [DMDACREATE3D] >>>> call >>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>> ---------^ >>>> global.F90(1021): error #6285: There is no matching specific subroutine >>>> for this generic subroutine call. [DMDACREATE3D] >>>> call >>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>> ---------^ >>>> global.F90(1029): error #6285: There is no matching specific subroutine >>>> for this generic subroutine call. [DMDACREATE3D] >>>> call >>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>> ---------^ >>>> compilation aborted for global.F90 (code 1) >>>> >>>> -- >>>> Thank you very much. >>>> >>>> Yours sincerely, >>>> >>>> ================================================ >>>> TAY Wee-Beng (Zheng Weiming) ??? >>>> Personal research webpage: http://tayweebeng.wixsite.com/website >>>> Youtube research showcase: https://www.youtube.com/channel/UC72ZHtvQNMpNs2uRTSToiLA >>>> linkedin: www.linkedin.com/in/tay-weebeng >>>> ================================================ >>>> >>>> >>>> >>>> -- >>>> 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 >>>> >>>> https://www.cse.buffalo.edu/~knepley/ > From rlmackie862 at gmail.com Thu Aug 30 22:36:20 2018 From: rlmackie862 at gmail.com (Randall Mackie) Date: Thu, 30 Aug 2018 20:36:20 -0700 Subject: [petsc-users] Problem compiling with 64bit PETSc In-Reply-To: <14BE4673-3EE5-48AC-96F1-288FCDA6517D@mcs.anl.gov> References: <2C69D0C3-5D83-4AD5-9B54-783A746DF0D9@anl.gov> <27433b40-13a9-0b4c-18b1-141b251c068f@gmail.com> <14BE4673-3EE5-48AC-96F1-288FCDA6517D@mcs.anl.gov> Message-ID: Don?t forget that not all integers passed into PETSc routines are 64 bit. For example, the error codes when called from Fortran should be defined as PetscErrorCode and not PetscInt. It?s really good to get into the habit of correctly declaring all PETSc variables according to the web pages, so that you can easily switch between 32bit and 64bit integers. Randy > On Aug 30, 2018, at 7:43 PM, Smith, Barry F. wrote: > > > >> On Aug 30, 2018, at 9:40 PM, TAY wee-beng wrote: >> >> >> On 31/8/2018 10:38 AM, Smith, Barry F. wrote: >>> PetscReal is by default real(8) you can leave those alone >>> >>> Any integer you pass to a PETSc routine needs to be declared as PetscInt (not integer) otherwise the 64 bit indices stuff won't work. >>> >>> Barry >>> >> Hi, >> >> ok, I got it. Btw, is it advisable to change all integer in my code to PetscInt? >> >> Will it cause any conflict or waste a lot of memory? >> >> Or should I only change those related to PETSc? > > That is up to you. Since you probably pass the values between PETSc and non-PETSc part of the code it is probably easier just to make all the integer PetscInt instead. No performance difference that you can measure by keeping a few integer around. > > Barry > >> >> Thanks! >>>> On Aug 30, 2018, at 9:35 PM, TAY wee-beng wrote: >>>> >>>> >>>> On 31/8/2018 10:21 AM, Matthew Knepley wrote: >>>>> On Thu, Aug 30, 2018 at 10:17 PM TAY wee-beng wrote: >>>>> Hi, >>>>> >>>>> Due to my increase grid size, I have to go 64bit. I compiled the 64bit >>>>> PETSc w/o error. However, when I tried to compile my code using the >>>>> 64bit PETSc, I got the error below. May I know why is this so? >>>>> >>>>> What changes should I make? >>>>> >>>>> Is it possible that you did not declare some inputs as PetscInt, so the interface check is failing? >>>>> >>>>> Matt >>>> Hi, >>>> >>>> I'm using the standard >>>> >>>> integer :: >>>> >>>> real(8) :: >>>> >>>> for some variables. For some others relating to PETSc, I use PetscInt. >>>> >>>> Should I change all to PetscInt and PetscReal? >>>> >>>> Currently, I use real(8) for all real values. If I change all to PetscReal, will PetscReal be real or real(8) by default? >>>> >>>> Thanks! >>>>> >>>>> [tsltaywb at nus02 ibm3d_IIB_mpi]$ make -f makefile_2018 >>>>> /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 >>>>> -g -ip -ipo -O3 -c -fPIC -save kinefunc.F90 >>>>> /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 >>>>> -g -ip -ipo -O3 -c -fPIC -save -w >>>>> -I/home/users/nus/tsltaywb/propeller/lib/petsc-3.9.3_intel_2018_64bit_rel/include >>>>> -I/app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/include >>>>> global.F90 >>>>> global.F90(979): error #6285: There is no matching specific subroutine >>>>> for this generic subroutine call. [DMDACREATE3D] >>>>> call >>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>> -----^ >>>>> global.F90(989): error #6285: There is no matching specific subroutine >>>>> for this generic subroutine call. [DMDACREATE3D] >>>>> call >>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>> ---------^ >>>>> global.F90(997): error #6285: There is no matching specific subroutine >>>>> for this generic subroutine call. [DMDACREATE3D] >>>>> call >>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>> ---------^ >>>>> global.F90(1005): error #6285: There is no matching specific subroutine >>>>> for this generic subroutine call. [DMDACREATE3D] >>>>> call >>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>> ---------^ >>>>> global.F90(1013): error #6285: There is no matching specific subroutine >>>>> for this generic subroutine call. [DMDACREATE3D] >>>>> call >>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>> ---------^ >>>>> global.F90(1021): error #6285: There is no matching specific subroutine >>>>> for this generic subroutine call. [DMDACREATE3D] >>>>> call >>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>> ---------^ >>>>> global.F90(1029): error #6285: There is no matching specific subroutine >>>>> for this generic subroutine call. [DMDACREATE3D] >>>>> call >>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>> ---------^ >>>>> compilation aborted for global.F90 (code 1) >>>>> >>>>> -- >>>>> Thank you very much. >>>>> >>>>> Yours sincerely, >>>>> >>>>> ================================================ >>>>> TAY Wee-Beng (Zheng Weiming) ??? >>>>> Personal research webpage: http://tayweebeng.wixsite.com/website >>>>> Youtube research showcase: https://www.youtube.com/channel/UC72ZHtvQNMpNs2uRTSToiLA >>>>> linkedin: www.linkedin.com/in/tay-weebeng >>>>> ================================================ >>>>> >>>>> >>>>> >>>>> -- >>>>> 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 >>>>> >>>>> https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From rupp at iue.tuwien.ac.at Thu Aug 30 23:50:42 2018 From: rupp at iue.tuwien.ac.at (Karl Rupp) Date: Fri, 31 Aug 2018 06:50:42 +0200 Subject: [petsc-users] MatSetValues error with ViennaCL types In-Reply-To: <87in3rookd.fsf@jedbrown.org> References: <6A7AE71B-95C1-4BC0-8086-58B008565BA1@mcs.anl.gov> <941297AF-952E-4875-969B-50C604660F1B@mcs.anl.gov> <87in3rookd.fsf@jedbrown.org> Message-ID: <96a0a87b-9196-ffcf-33d6-de224995856d@iue.tuwien.ac.at> >> I thought newer NVIDIA cards had integrated circuits, not using PCI >> anymore, still the same case? > > NVLink is much faster than PCI, but it's still a bus that is slower (and > higher latency) than aggregate DDR, though there are open questions > about how much message packing (for example) should take place on GPU > versus CPU. To add: NVLink has higher bandwidth, but as far as I know it has about the same latency. That is, if you send just a few (kilo-)bytes around, you'll see the same latency problems as with PCI-Express. Best regards, Karli From srahul_05 at yahoo.co.in Fri Aug 31 00:26:37 2018 From: srahul_05 at yahoo.co.in (Rahul Samala) Date: Fri, 31 Aug 2018 05:26:37 +0000 (UTC) Subject: [petsc-users] Problem with SNES convergence In-Reply-To: <7337A99E-C3BE-48EF-BC95-4A1736227F8E@mcs.anl.gov> References: <1371398831.496454.1535553418412.ref@mail.yahoo.com> <1371398831.496454.1535553418412@mail.yahoo.com> <387994F6-79FF-4DE4-8375-B24F63B0F332@anl.gov> <1135178798.714456.1535603850997@mail.yahoo.com> <7337A99E-C3BE-48EF-BC95-4A1736227F8E@mcs.anl.gov> Message-ID: <469723814.1317957.1535693197280@mail.yahoo.com> Thank you Barry for the suggestion, I will definitely look in to TS implementation. I have implemented my own version of reduced time step size using the?SNESGetConvergedReason, but encountered the same problem after another 30 time-steps. So, I am experimenting with different set of initial conditions. Ling, thank you for the code, I will see if my understanding is different from yours. --Rahul. On Thursday, August 30, 2018, 11:25:35 PM GMT+5:30, Smith, Barry F. wrote: > On Aug 30, 2018, at 12:49 PM, Fande Kong wrote: > > Hi Barry, > > I haven't had time to look into TS so far. But it is definitely interesting. One simple question would like this: If I have a? simple loop for time steppers, and each step SNES is called. How hard to convert my code to use TS? ? ? You would need to look at the examples in ts/examples/tutorials but essentially you need to provide a slightly different version of FormFunction() and FormJacobian() and call TSSolve() etc instead of having your own loop. ? ? Barry > > Any suggestion? Where should I start from? > > > Fande, > > On Thu, Aug 30, 2018 at 11:29 AM Smith, Barry F. wrote: > >? ? Note also that the PETSc TS component has a large variety of timesteppers with automatic adaptivity which adjust the time-step for accuracy and convergence. Depending on the exact needs of your time-stepper it might be easier in the long run to use PETSc's time-steppers rather than write your own. > >? ? Barry > > > > On Aug 30, 2018, at 10:46 AM, Ling Zou wrote: > > > > Rahul, please see the logic I used to reduce time step size. > > Hope this helps you. > > > > Ling > > > > for (timestep = 1; timestep <= N; timestep++) // loop over time steps > > { > >? // before trying to solve a time step, 1) it is still not successful; 2) we are not giving up; 3) haven't failed yet > >? bool give_up = false; bool success = false; bool experienced_fail_this_time_step = false; > >? // save solutions and old solutions into u_copy and u_old_copy, in case a time step fails and we restart from this saved solutions > >? VecCopy(u, u_copy); VecCopy(u_old, u_old_copy); > > > >? while ((!give_up) && (!success)) // as long as not successful and not giving up, we solve again with smaller time step > >? { > >? ? if (time_step_size < dt_min) { give_up = true; break; } // ok, bad luck, give up due to time step size smaller than a preset value > >? ? if (experienced_fail_this_time_step) { // get the vectors from backups if this is a re-try, i.e., already failed with a larger time step > >? ? ? VecCopy(u_old_copy, u); VecCopy(u_old_copy, u_old); > >? ? } > > > >? ? try { > >? ? ? SNESSolve(snes, NULL, u); > >? ? ? SNESGetConvergedReason(snes, &snes_converged_reason); > > > >? ? ? if (snes_converged_reason > 0)? success = true; // yes, snes converged > >? ? ? else { // no, snes did not converge > >? ? ? ? cutTimeStepSize(); // e.g., dt / 2 > >? ? ? ? experienced_fail_this_time_step = true; > >? ? ? } > >? ? } > >? ? catch (int err) { // in case your own pieces of code throws an exception > >? ? ? std::cout << "An exception occurred." << std::endl; > >? ? ? success = false; > >? ? ? cutTimeStepSize(); // e.g., dt / 2 > >? ? ? experienced_fail_this_time_step = true; > >? ? } > >? } > > > >? if (success) { > >? ? // output, print, whatever > >? ? // duplicate current solution to old solution in preparing next time step > >? ? VecCopy(u, u_old); > >? ? // you can increase time step size here, e.g. * 2 > >? ? increaseTimeStepSize(); > >? } > > > >? if (give_up) { > >? ? simulationFailed = true; > >? ? std::cerr << "Simulation failed.\n"; > >? ? //exit(1);// dont exit(1) now, just break the for-loop, let PETSc clean its workspace. > >? ? break; > >? } > > } > > > > From: Rahul Samala > > Sent: Wednesday, August 29, 2018 10:37:30 PM > > To: Ling Zou; Smith, Barry F. > > Cc: PETSc Users List > > Subject: Re: [petsc-users] Problem with SNES convergence > >? > > Thank you Ling, I would definitely like to look at your code for reducing timestep size. > > Thank you Barry for your inputs. > > > > -- > > Rahul. > > > > On Wednesday, August 29, 2018, 9:02:00 PM GMT+5:30, Smith, Barry F. wrote: > > > > > > > > Current time (before start of timestep) 52.5048,? ? iter=5380? ? Timestep=864.000000 > >? 0 SNES Function norm 1.650467412595e+05 > >? ? 0 KSP preconditioned resid norm 3.979123221160e+03 true resid norm 1.650467412595e+05 ||r(i)||/||b|| 1.000000000000e+00 > >? ? 1 KSP preconditioned resid norm 9.178246525982e-11 true resid norm 7.006473307032e-09 ||r(i)||/||b|| 4.245144892632e-14 > >? Linear solve converged due to CONVERGED_RTOL iterations 1 > >? 1 SNES Function norm 6.722712947273e+02 > >? Linear solve did not converge due to DIVERGED_NANORINF iterations 0 > > Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE iterations 1 > > > >? ? This usually is an indicator that the LU (ILU) factorization has hit a zero pivot (hence the linear solve has a divide by zero so gives the DIVERGED_NANORINF flag). > > > >? ? You can/should call SNESGetConvergedReason() immediately after each SNESSolve(), if the result is negative that means something has failed in the nonlinear solve and you can try cutting the time-step and trying again. > > > >? ? Good luck, > > > >? ? Barry > > > > > > > On Aug 29, 2018, at 10:11 AM, Ling Zou wrote: > > > > > > 1) My experience is that this kind of bug or sudden death (everything is fine till suddenly something is broken) is very difficult to debug/fix. I looked at your txt files and could not give any quick comments. Maybe PETSc developers have better idea on this. > > > 2) I do have successful experience on reducing time step size when PETSc fails solving or my own piece of code throws an exception. If you are interested, I can share them. > > > > > > -Ling > > > From: petsc-users on behalf of Rahul Samala > > > Sent: Wednesday, August 29, 2018 8:36:58 AM > > > To: PETSc Users List > > > Subject: [petsc-users] Problem with SNES convergence > > >? > > > Hello PetSc users, > > > > > > 1)? I have problem with SNES convergence. I call SNESSolve? in a time loop and use the inbuilt Jacobian feature. The code works fine for about 5380 time steps after which it breaks down. The solution till that point looks fine. I have used newtonls of type l2. (newtontr and others aren't working). Since I have used inbuilt Jacobian feature and the code worked for about 5000 time steps I don't understand the reason for failure, is it an incorrect function evaluation?? Attached are the outputs with -pc_type lu and ilu along with -snes_linesearch_type l2 -snes_converged_reason -snes_monitor -snes_view -ksp_converged_reason -ksp_monitor_true_residual > > > > > > 2)? How to get hold of failure signal, like Nonlinear solve DIVERGED_MAX_IT or DIVERGED_LINEAR_SOLVE so that whenever it occurs I can use a reduced time step and see if the code converges. > > > > > > Thank you, > > > Rahul. > > > > > > output_ilu.txt > > > > > >? ? > > > output_ilu.txt > > > > > > > > > > > > output_lu.txt > > > > > >? ? > > > output_lu.txt > -------------- next part -------------- An HTML attachment was scrubbed... URL: From zonexo at gmail.com Fri Aug 31 00:52:12 2018 From: zonexo at gmail.com (TAY wee-beng) Date: Fri, 31 Aug 2018 13:52:12 +0800 Subject: [petsc-users] Problem compiling with 64bit PETSc In-Reply-To: References: <2C69D0C3-5D83-4AD5-9B54-783A746DF0D9@anl.gov> <27433b40-13a9-0b4c-18b1-141b251c068f@gmail.com> <14BE4673-3EE5-48AC-96F1-288FCDA6517D@mcs.anl.gov> Message-ID: Hi Randy, I was about to email why it didn't work even after changing them to PetscInt. Then I realise that ierr should be defined as PetscErrorCode. Thank you very much. Yours sincerely, ================================================ TAY Wee-Beng (Zheng Weiming) ??? Personal research webpage: http://tayweebeng.wixsite.com/website Youtube research showcase: https://www.youtube.com/channel/UC72ZHtvQNMpNs2uRTSToiLA linkedin: www.linkedin.com/in/tay-weebeng ================================================ On 31/8/2018 11:36 AM, Randall Mackie wrote: > Don?t forget that not all integers passed into PETSc routines are 64 bit. > For example, the error codes when called from Fortran should be > defined as PetscErrorCode and not PetscInt. > It?s really good to get into the habit of correctly declaring all > PETSc variables according to the web pages, so that you can easily > switch between 32bit and 64bit integers. > > Randy > > >> On Aug 30, 2018, at 7:43 PM, Smith, Barry F. > > wrote: >> >> >> >>> On Aug 30, 2018, at 9:40 PM, TAY wee-beng >> > wrote: >>> >>> >>> On 31/8/2018 10:38 AM, Smith, Barry F. wrote: >>>> ?PetscReal is by default real(8) you can leave those alone >>>> >>>> ??Any integer you pass to a PETSc routine needs to be declared as >>>> PetscInt (not integer) otherwise the 64 bit indices stuff won't work. >>>> >>>> ??Barry >>>> >>> Hi, >>> >>> ok, I got it. Btw, is it advisable to change all integer in my code >>> to PetscInt? >>> >>> Will it cause any conflict or waste a lot of memory? >>> >>> Or should I only change those related to PETSc? >> >> ???That is up to you. Since you probably pass the values between >> PETSc and non-PETSc part of the code it is probably easier just to >> make all the integer PetscInt instead. No performance difference that >> you can measure by keeping a few integer around. >> >> ???Barry >> >>> >>> Thanks! >>>>> On Aug 30, 2018, at 9:35 PM, TAY wee-beng >>>> > wrote: >>>>> >>>>> >>>>> On 31/8/2018 10:21 AM, Matthew Knepley wrote: >>>>>> On Thu, Aug 30, 2018 at 10:17 PM TAY wee-beng >>>>> > wrote: >>>>>> Hi, >>>>>> >>>>>> Due to my increase grid size, I have to go 64bit. I compiled the >>>>>> 64bit >>>>>> PETSc w/o error. However, when I tried to compile my code using the >>>>>> 64bit PETSc, I got the error below. May I know why is this so? >>>>>> >>>>>> What changes should I make? >>>>>> >>>>>> Is it possible that you did not declare some inputs as PetscInt, >>>>>> so the interface check is failing? >>>>>> >>>>>> ??Matt >>>>> Hi, >>>>> >>>>> I'm using the standard >>>>> >>>>> integer :: >>>>> >>>>> real(8) :: >>>>> >>>>> for some variables. For some others relating to PETSc, I use PetscInt. >>>>> >>>>> Should I change all to PetscInt and PetscReal? >>>>> >>>>> Currently, I use real(8) for all real values. If I change all to >>>>> PetscReal, will PetscReal be real or real(8) by default? >>>>> >>>>> Thanks! >>>>>> >>>>>> [tsltaywb at nus02 ibm3d_IIB_mpi]$ make -f makefile_2018 >>>>>> /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 >>>>>> -g -ip -ipo -O3 -c -fPIC ?-save kinefunc.F90 >>>>>> /app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/bin/mpif90 >>>>>> -g -ip -ipo -O3 -c -fPIC ?-save ?-w >>>>>> -I/home/users/nus/tsltaywb/propeller/lib/petsc-3.9.3_intel_2018_64bit_rel/include >>>>>> -I/app/intel/xe2018/compilers_and_libraries_2018.0.128/linux/mpi/intel64/include >>>>>> global.F90 >>>>>> global.F90(979): error #6285: There is no matching specific >>>>>> subroutine >>>>>> for this generic subroutine call. ??[DMDACREATE3D] >>>>>> call >>>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>>> -----^ >>>>>> global.F90(989): error #6285: There is no matching specific >>>>>> subroutine >>>>>> for this generic subroutine call. ??[DMDACREATE3D] >>>>>> ????call >>>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>>> ---------^ >>>>>> global.F90(997): error #6285: There is no matching specific >>>>>> subroutine >>>>>> for this generic subroutine call. ??[DMDACREATE3D] >>>>>> ????call >>>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>>> ---------^ >>>>>> global.F90(1005): error #6285: There is no matching specific >>>>>> subroutine >>>>>> for this generic subroutine call. ??[DMDACREATE3D] >>>>>> ????call >>>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>>> ---------^ >>>>>> global.F90(1013): error #6285: There is no matching specific >>>>>> subroutine >>>>>> for this generic subroutine call. ??[DMDACREATE3D] >>>>>> ????call >>>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>>> ---------^ >>>>>> global.F90(1021): error #6285: There is no matching specific >>>>>> subroutine >>>>>> for this generic subroutine call. ??[DMDACREATE3D] >>>>>> ????call >>>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>>> ---------^ >>>>>> global.F90(1029): error #6285: There is no matching specific >>>>>> subroutine >>>>>> for this generic subroutine call. ??[DMDACREATE3D] >>>>>> ????call >>>>>> DMDACreate3d(MPI_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_STAR,size_x,size_y,& >>>>>> ---------^ >>>>>> compilation aborted for global.F90 (code 1) >>>>>> >>>>>> -- >>>>>> Thank you very much. >>>>>> >>>>>> Yours sincerely, >>>>>> >>>>>> ================================================ >>>>>> TAY Wee-Beng (Zheng Weiming) ??? >>>>>> Personal research webpage: http://tayweebeng.wixsite.com/website >>>>>> Youtube research showcase: >>>>>> https://www.youtube.com/channel/UC72ZHtvQNMpNs2uRTSToiLA >>>>>> linkedin: www.linkedin.com/in/tay-weebeng >>>>>> >>>>>> ================================================ >>>>>> >>>>>> >>>>>> >>>>>> -- >>>>>> 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 >>>>>> >>>>>> https://www.cse.buffalo.edu/~knepley/ >>>>>> > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mbuerkle at web.de Fri Aug 31 02:03:18 2018 From: mbuerkle at web.de (Marius Buerkle) Date: Fri, 31 Aug 2018 09:03:18 +0200 Subject: [petsc-users] mkl_cpardiso: Matrix B must be MATSEQDENSE matrix Message-ID: An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Aug 31 02:36:01 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Fri, 31 Aug 2018 07:36:01 +0000 Subject: [petsc-users] mkl_cpardiso: Matrix B must be MATSEQDENSE matrix In-Reply-To: References: Message-ID: <2337A14F-0FD9-4DF9-9427-5CC3DED9887D@anl.gov> Marius, Try editing src/mat/impls/aij/mpi/mkl_cpardiso/mkl_cpardiso.c at the subroutine MatMatSolve_MKL_CPARDISO() and remove the lines ierr = PetscObjectTypeCompare((PetscObject)B,MATSEQDENSE,&flg);CHKERRQ(ierr); if (!flg) SETERRQ(PetscObjectComm((PetscObject)A),PETSC_ERR_ARG_WRONG,"Matrix B must be MATSEQDENSE matrix"); ierr = PetscObjectTypeCompare((PetscObject)X,MATSEQDENSE,&flg);CHKERRQ(ierr); if (!flg) SETERRQ(PetscObjectComm((PetscObject)A),PETSC_ERR_ARG_WRONG,"Matrix X must be MATSEQDENSE matrix"); Run make gnumake then try compiling and running your application again. Barry It could be that this code was cut and pasted from some other solver (Mumps) and hence has checks for SEQDENSE that are not needed for MKL_CPARDISO. > On Aug 31, 2018, at 2:03 AM, Marius Buerkle wrote: > > Hi ! > > I tried to use MKL_CPARDISO solver in parallel but I get the following error > > [0]PETSC ERROR: Invalid argument > [0]PETSC ERROR: Matrix B must be MATSEQDENSE matrix > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1202-ge6d955127a GIT Date: 2018-08-23 16:59:59 -0500 > [0]PETSC ERROR: /home/marius/prog/ownstuff/fortran/programs/transomat_dev/transomat/transomat on a named tono-hpc1 by marius Fri Aug 31 15:57:15 2018 > [0]PETSC ERROR: Configure options --prefix=/home/marius/prog/petsc/master_opt --with-64-bit-indices=0 --CC=mpicc --COPTFLAGS="-O3 -march=native -g -std=c11" --CXX=mpicxx --CXXOPTFLAGS="-O3 -march=native -g -std=c++11" --FC=mpiifort --FOPTFLAGS="-O2 -xHost -g" --with-mpi=1 --with-x=1 --download-parmetis=yes --download-metis=yes --download-ptscotch=yes --download-scotch=yes --download-mumps=yes --with-blaslapack-lib="-L/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl/lib/intel64 -lmkl_scalapack_lp64 -lmkl_intel_lp64 -lmkl_intel_thread -lmkl_core -lmkl_blacs_intelmpi_lp64 -liomp5 -lpthread -lm -ldl" --with-scalapack-lib="-L/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl/lib/intel64 -lmkl_scalapack_lp64 -lmkl_intel_lp64 -lmkl_intel_thread -lmkl_core -lmkl_blacs_intelmpi_lp64 -liomp5 -lpthread -lm -ldl" --download-pastix=no --download-superlu_dist=yes --download-superlu_dist-commit=803c8ab665b33e9136b199c4521be465e026bb0d --download-hwloc=yes --with-mkl_pardiso-dir=/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl --with-openmp=0 --with-pthread=0 --download-elemental=yes --download-elemental-commit=de7b5bea1abf5f626b91582f742cf99e2e551bff --with-mkl_cpardiso-dir=/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl --with-mkl_sparse_optimize-dir=/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl --with-mkl_sparse_sp2m-dir=/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl --download-sowing=yes --with-cxx-dialect=c++11 --with-scalar-type=complex --with-debugging=0 > [0]PETSC ERROR: #1 MatMatSolve_MKL_CPARDISO() line 319 in /home/marius/prog/petsc/petsc/src/mat/impls/aij/mpi/mkl_cpardiso/mkl_cpardiso.c > [0]PETSC ERROR: #2 MatMatSolve() line 3385 in /home/marius/prog/petsc/petsc/src/mat/interface/matrix.c > > > I wonder isn't CPARDISO supposed to work with MATMPIDENSE ? > > best, > marius From mbuerkle at web.de Fri Aug 31 04:16:45 2018 From: mbuerkle at web.de (Marius Buerkle) Date: Fri, 31 Aug 2018 11:16:45 +0200 Subject: [petsc-users] mkl_cpardiso: Matrix B must be MATSEQDENSE matrix In-Reply-To: <2337A14F-0FD9-4DF9-9427-5CC3DED9887D@anl.gov> References: <2337A14F-0FD9-4DF9-9427-5CC3DED9887D@anl.gov> Message-ID: An HTML attachment was scrubbed... URL: From giacomo.mulas at inaf.it Fri Aug 31 06:34:04 2018 From: giacomo.mulas at inaf.it (Giacomo Mulas) Date: Fri, 31 Aug 2018 13:34:04 +0200 (CEST) Subject: [petsc-users] converting matrices between petsc and scalapack/blacs format? Message-ID: Hello. I have a relatively silly problem: in a software I developed, which originally always used SLEPC, I now introduced support for using also scalapack and elpa as eigensolvers, in cases in which this is convenient. Is there a simple way to have PETSC create a matrix in blacs compatible format? Alternatively, I am thinking to use MatView to write the PETSC matrix to a file and then read it back. This would also have the nice side-effect to enable me to separate the part of the code the sets up and creates the matrix from the part the calls the appropriate eigensolver. The best thing would be to use MatView to write a binary file and then create a simple function to reread it, create a blacs matrix and populate it appropriately. In the docs for MatLoad() the format of binary files created by MatView is given in terms of int and PetscScalar values. Now, since in some cases (on some machines) I compiled PETSC to use 64 bit indices, I need to be extra careful on what "int" means! Is it just "int", or PetscInt, or PetscBLASInt, or...? From a quick look at MatView_MPIAIJ_Binary() I would guess they are PetscInt and are written by calls to PetscBinaryWrite(), meaning I should use calls to PetscBinaryRead() to get them back. Is this correct? Thanks in advance Giacomo -- _________________________________________________________________ Giacomo Mulas _________________________________________________________________ INAF - Osservatorio Astronomico di Cagliari via della scienza 5 - 09047 Selargius (CA) tel. +39 070 71180255 mob. : +39 329 6603810 _________________________________________________________________ "When the storms are raging around you, stay right where you are" (Freddy Mercury) _________________________________________________________________ From knepley at gmail.com Fri Aug 31 06:41:54 2018 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 31 Aug 2018 07:41:54 -0400 Subject: [petsc-users] converting matrices between petsc and scalapack/blacs format? In-Reply-To: References: Message-ID: On Fri, Aug 31, 2018 at 7:34 AM Giacomo Mulas wrote: > Hello. > > I have a relatively silly problem: in a software I developed, which > originally always used SLEPC, I now introduced support for using also > scalapack and elpa as eigensolvers, in cases in which this is convenient. > Is there a simple way to have PETSC create a matrix in blacs compatible > format? > > Alternatively, I am thinking to use MatView to write the PETSC matrix to a > file and then read it back. This would also have the nice side-effect to > enable me to separate the part of the code the sets up and creates the > matrix from the part the calls the appropriate eigensolver. The best thing > would be to use MatView to write a binary file and then create a simple > function to reread it, create a blacs matrix and populate it > appropriately. > In the docs for MatLoad() the format of binary files created by MatView is > given in terms of int and PetscScalar values. Now, since in some cases (on > some machines) I compiled PETSC to use 64 bit indices, I need to be extra > careful on what "int" means! Is it just "int", or PetscInt, or > PetscBLASInt, or...? From a quick look at MatView_MPIAIJ_Binary() I would > guess they are PetscInt and are written by calls to PetscBinaryWrite(), > meaning I should use calls to PetscBinaryRead() to get them back. Is this > correct? > Yes, that is all correct. I wonder if you could convince a) SLEPc to support Elpa, or better convince Elpa to support Elemental. BLACS is icky inside :) Thanks, Matt > Thanks in advance > Giacomo > > -- > _________________________________________________________________ > > Giacomo Mulas > _________________________________________________________________ > > INAF - Osservatorio Astronomico di Cagliari > via della scienza 5 - 09047 Selargius (CA) > > tel. +39 070 71180255 > mob. : +39 329 6603810 > _________________________________________________________________ > > "When the storms are raging around you, stay right where you are" > (Freddy Mercury) > _________________________________________________________________ > -- 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 https://www.cse.buffalo.edu/~knepley/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From giacomo.mulas at inaf.it Fri Aug 31 11:32:51 2018 From: giacomo.mulas at inaf.it (Giacomo Mulas) Date: Fri, 31 Aug 2018 18:32:51 +0200 (CEST) Subject: [petsc-users] converting matrices between petsc and scalapack/blacs format? In-Reply-To: References: Message-ID: On Fri, 31 Aug 2018, Matthew Knepley wrote: > Yes, that is all correct. I wonder if you could convince a) SLEPc to > support Elpa, or better convince Elpa to support Elemental. BLACS is icky > inside :) Yes, I know BLACS is... complicated, and I'd rather do without it altogether if I could. But unfortunately both ELPA and the scalapack implementation in MKL distribute big arrays with that. And I'm afraid I have no superpowers to convince either SLEPc to support Elpa or Elpa to support Elemental, unfortunately. I'm a mere end (ab)user... Thanks for your help. I was able to reread a Petsc matrix saved via MatView in binary format into a BLACS one, it was not even as bad as I was afraid it would be. Cheers Giacomo -- _________________________________________________________________ Giacomo Mulas _________________________________________________________________ INAF - Osservatorio Astronomico di Cagliari via della scienza 5 - 09047 Selargius (CA) tel. +39 070 71180255 mob. : +39 329 6603810 _________________________________________________________________ "When the storms are raging around you, stay right where you are" (Freddy Mercury) _________________________________________________________________ From huq2090 at gmail.com Fri Aug 31 12:12:53 2018 From: huq2090 at gmail.com (Fazlul Huq) Date: Fri, 31 Aug 2018 12:12:53 -0500 Subject: [petsc-users] Using C routines in PETSc code Message-ID: Hello PETSc Developers, Can I use c programming routine in PETSc code and make and run it (since PETSc is written in c)? Last day I tried to do that but I got error message while making the file. Thanks. Huq -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Aug 31 12:18:41 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Fri, 31 Aug 2018 17:18:41 +0000 Subject: [petsc-users] mkl_cpardiso: Matrix B must be MATSEQDENSE matrix RICHARD MILLS READ THIS! In-Reply-To: References: <2337A14F-0FD9-4DF9-9427-5CC3DED9887D@anl.gov> Message-ID: <780DB35E-C066-40B0-8B21-2F2BA438B367@mcs.anl.gov> Thanks for the update. > On Aug 31, 2018, at 4:16 AM, Marius Buerkle wrote: > > Thanks. I had addtionally to change MatDenseGet/RestoreArrayRead(B,&barray); to MatDenseGet/RestoreArray(B,&barray); as I got > > [1]PETSC ERROR: No support for this operation for this object type > > [1]PETSC ERROR: Cannot locate function MatDenseRestoreArrayRead_C in object > > I have fixed this in the maint and master branch. I have also removed the error check that required on MATSEQDENSE in maint and master so now your code should run properly with maint or master without needing you to change PETSc code. > > > One more question, do I need to use MATAIJMKL as matrix type? To use MatMatSolve() with MKL_CPADISO you do NOT need need to use MATAIJMKL. MATAIJMKL is actually for some optimized matrix-vector operations that MKL provides and has nothing to do with MKL_CPADISO. (But since MATAIJMKL is a subclass of MATAIJ it will work with functions that work with MATAIJ such as the MatMatSolve with MKL_CPADISO.) > It seems to work fine with MATAIJ. And another odd thing I realized is that when I use MatAXPY on two MATAIJMKL wit DIFFERENT_NONZERO_PATTERN the resulting matrix Y is of type MATAIJ. This is a mis-feature, I''l report it to Richard Mills and he can determine how difficult it would be to fix (I think is should be easy just need a MatAXPY_XXXAIJMKL wrapper that uses the correct type and then calls MatAXPY_XXXAIJ) Barry > > best, > Marius > > > Marius, > > Try editing src/mat/impls/aij/mpi/mkl_cpardiso/mkl_cpardiso.c at the subroutine MatMatSolve_MKL_CPARDISO() and remove the lines > > ierr = PetscObjectTypeCompare((PetscObject)B,MATSEQDENSE,&flg);CHKERRQ(ierr); > if (!flg) SETERRQ(PetscObjectComm((PetscObject)A),PETSC_ERR_ARG_WRONG,"Matrix B must be MATSEQDENSE matrix"); > ierr = PetscObjectTypeCompare((PetscObject)X,MATSEQDENSE,&flg);CHKERRQ(ierr); > if (!flg) SETERRQ(PetscObjectComm((PetscObject)A),PETSC_ERR_ARG_WRONG,"Matrix X must be MATSEQDENSE matrix"); > > Run > > make gnumake > > then try compiling and running your application again. > > Barry > > It could be that this code was cut and pasted from some other solver (Mumps) and hence has checks for SEQDENSE that are not needed for MKL_CPARDISO. > > > > On Aug 31, 2018, at 2:03 AM, Marius Buerkle wrote: > > > > Hi ! > > > > I tried to use MKL_CPARDISO solver in parallel but I get the following error > > > > [0]PETSC ERROR: Invalid argument > > [0]PETSC ERROR: Matrix B must be MATSEQDENSE matrix > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.9.3-1202-ge6d955127a GIT Date: 2018-08-23 16:59:59 -0500 > > [0]PETSC ERROR: /home/marius/prog/ownstuff/fortran/programs/transomat_dev/transomat/transomat on a named tono-hpc1 by marius Fri Aug 31 15:57:15 2018 > > [0]PETSC ERROR: Configure options --prefix=/home/marius/prog/petsc/master_opt --with-64-bit-indices=0 --CC=mpicc --COPTFLAGS="-O3 -march=native -g -std=c11" --CXX=mpicxx --CXXOPTFLAGS="-O3 -march=native -g -std=c++11" --FC=mpiifort --FOPTFLAGS="-O2 -xHost -g" --with-mpi=1 --with-x=1 --download-parmetis=yes --download-metis=yes --download-ptscotch=yes --download-scotch=yes --download-mumps=yes --with-blaslapack-lib="-L/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl/lib/intel64 -lmkl_scalapack_lp64 -lmkl_intel_lp64 -lmkl_intel_thread -lmkl_core -lmkl_blacs_intelmpi_lp64 -liomp5 -lpthread -lm -ldl" --with-scalapack-lib="-L/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl/lib/intel64 -lmkl_scalapack_lp64 -lmkl_intel_lp64 -lmkl_intel_thread -lmkl_core -lmkl_blacs_intelmpi_lp64 -liomp5 -lpthread -lm -ldl" --download-pastix=no --download-superlu_dist=yes --download-superlu_dist-commit=803c8ab665b33e9136b199c4521be465e026bb0d --download-hwloc=yes --with-mkl_pardiso-dir=/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl --with-openmp=0 --with-pthread=0 --download-elemental=yes --download-elemental-commit=de7b5bea1abf5f626b91582f742cf99e2e551bff --with-mkl_cpardiso-dir=/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl --with-mkl_sparse_optimize-dir=/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl --with-mkl_sparse_sp2m-dir=/home/marius/intel/compilers_and_libraries_2018.3.222/linux/mkl --download-sowing=yes --with-cxx-dialect=c++11 --with-scalar-type=complex --with-debugging=0 > > [0]PETSC ERROR: #1 MatMatSolve_MKL_CPARDISO() line 319 in /home/marius/prog/petsc/petsc/src/mat/impls/aij/mpi/mkl_cpardiso/mkl_cpardiso.c > > [0]PETSC ERROR: #2 MatMatSolve() line 3385 in /home/marius/prog/petsc/petsc/src/mat/interface/matrix.c > > > > > > I wonder isn't CPARDISO supposed to work with MATMPIDENSE ? > > > > best, > > marius > From bsmith at mcs.anl.gov Fri Aug 31 12:43:00 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Fri, 31 Aug 2018 17:43:00 +0000 Subject: [petsc-users] Using C routines in PETSc code In-Reply-To: References: Message-ID: <77A92717-9D99-4947-9BC4-47A61158D4F9@anl.gov> > On Aug 31, 2018, at 12:12 PM, Fazlul Huq wrote: > > Hello PETSc Developers, > Can I use c programming routine in PETSc code and make and run it (since PETSc is written in c)? Of course. > Last day I tried to do that but I got error message while making the file. Must be due to syntax errors in the code. You should read the error messages to determine how to fix the code. Barry > > Thanks. > Huq > > From huq2090 at gmail.com Fri Aug 31 12:45:16 2018 From: huq2090 at gmail.com (Fazlul Huq) Date: Fri, 31 Aug 2018 12:45:16 -0500 Subject: [petsc-users] Using C routines in PETSc code In-Reply-To: <77A92717-9D99-4947-9BC4-47A61158D4F9@anl.gov> References: <77A92717-9D99-4947-9BC4-47A61158D4F9@anl.gov> Message-ID: Thanks Barry. I will try to fix the error. Sincerely, Huq On Fri, Aug 31, 2018 at 12:43 PM Smith, Barry F. wrote: > > > > On Aug 31, 2018, at 12:12 PM, Fazlul Huq wrote: > > > > Hello PETSc Developers, > > Can I use c programming routine in PETSc code and make and run it (since > PETSc is written in c)? > > Of course. > > > Last day I tried to do that but I got error message while making the > file. > > Must be due to syntax errors in the code. You should read the error > messages to determine how to fix the code. > > Barry > > > > > Thanks. > > Huq > > > > > > -- Fazlul Huq Graduate Research Assistant Department of Nuclear, Plasma & Radiological Engineering (NPRE) University of Illinois at Urbana-Champaign (UIUC) E-mail: huq2090 at gmail.com -------------- next part -------------- An HTML attachment was scrubbed... URL: From olk548 at mail.usask.ca Fri Aug 31 20:31:07 2018 From: olk548 at mail.usask.ca (Oleksandr Koshkarov) Date: Fri, 31 Aug 2018 19:31:07 -0600 Subject: [petsc-users] advice about preconditioning Message-ID: <27212880-f809-b90a-b7f4-65ee47d3821c@mail.usask.ca> Dear All, I hope you can help me with some advice on how to proceed with constructing a preconditioner for my petsc based simulation. I have a large nonlinear system dU/dt = L(U) + N(U,U), with U being a state vector, L linear operator and N nonlinear one. It comes from discretizing hyperbolic PDE with finite volume. L is advection and N is some nonlinear source which does not have spatial derivatives. My U is PETSc 3D DMDA with dof = from 1e2 up to 2e3. I solve it with petsc TS object and with Crank Nicolson method. In order to save space, I do use finite difference Jacobian, which petsc generates itself. Something like this ??? MatCreateSNESMF(snes,&J); ??? SNESSetJacobian(snes,J,J,MatMFFDComputeJacobian,0); Now I want to precondition my linear solves inside Newton iterations with linearized Jacobian, i.e, with something like this ?P_n = 1 - dt/2 * ( L + N(U^n,*) + N(*,U^n) )??????? // where U^n is state from previous time step I first checked, that this works on small test problem. I used matrix free preconditioner (PCSHELL) inside which I inverted P_n with KSP. Where? P_n is matrix free matrix (shell matrix). It reduces the number of KSP dramatically, which is not a surprise - it was just a sanity check. Now I am trying to understand how to proceed... and I am not sure what to do. In my head I have two options: 1) Try to construct matrix-free preconditioner. For example, I can keep inverting P_n every iteration inside the preconditioner with KSP (or some other method) but now precondition it with something else, to make it cheap. So I would have double preconditioner...? I am not sure if this is a right direction, and it is even possible to make effective matrix-free preconditioner in my case 2) Construct P_n as real matrix, and feed it to petsc (SNESSetJacobian(snes,J,P,MatMFFDComputeJacobian,0);) and ask to perform something like LU for preconditioning. It is very expensive (as I have huge system) and I would need to probably contract P_n only every 100 steps or something like this... It is probably the right direction I have to go, but it seems it will take too much memory. Is there other better way? :) Small question. If I will need to construct P_n element by element, does petsc provide some help with DMDA indexing. I usually access state U with x-index (xi), y-index (yi), z-index(zi), and dof like u[zi][yi][xi][dof]. Can I use similar indexing to access matrix elements? Thank you and best regards, Oleksandr. From bsmith at mcs.anl.gov Fri Aug 31 21:52:57 2018 From: bsmith at mcs.anl.gov (Smith, Barry F.) Date: Sat, 1 Sep 2018 02:52:57 +0000 Subject: [petsc-users] advice about preconditioning In-Reply-To: <27212880-f809-b90a-b7f4-65ee47d3821c@mail.usask.ca> References: <27212880-f809-b90a-b7f4-65ee47d3821c@mail.usask.ca> Message-ID: <7895B3FE-C9E3-4410-B5BB-DAC01E57DD6E@anl.gov> > On Aug 31, 2018, at 8:31 PM, Oleksandr Koshkarov wrote: > > Dear All, > > I hope you can help me with some advice on how to proceed with constructing a preconditioner for my petsc based simulation. > > I have a large nonlinear system dU/dt = L(U) + N(U,U), with U being a state vector, L linear operator and N nonlinear one. It comes from discretizing hyperbolic PDE with finite volume. L is advection and N is some nonlinear source which does not have spatial derivatives. My U is PETSc 3D DMDA with dof = from 1e2 up to 2e3. I solve it with petsc TS object and with Crank Nicolson method. In order to save space, I do use finite difference Jacobian, which petsc generates itself. Something like this > > MatCreateSNESMF(snes,&J); > SNESSetJacobian(snes,J,J,MatMFFDComputeJacobian,0); > > Now I want to precondition my linear solves inside Newton iterations with linearized Jacobian, i.e, with something like this > > P_n = 1 - dt/2 * ( L + N(U^n,*) + N(*,U^n) ) // where U^n is state from previous time step > > I first checked, that this works on small test problem. I used matrix free preconditioner (PCSHELL) inside which I inverted P_n with KSP. > > Where P_n is matrix free matrix (shell matrix). It reduces the number of KSP dramatically, which is not a surprise - it was just a sanity check. > > Now I am trying to understand how to proceed... and I am not sure what to do. In my head I have two options: > > 1) Try to construct matrix-free preconditioner. For example, I can keep inverting P_n every iteration inside the preconditioner with KSP (or some other method) but now precondition it with something else, to make it cheap. So I would have double preconditioner... I am not sure if this is a right direction, and it is even possible to make effective matrix-free preconditioner in my case > > 2) Construct P_n as real matrix, and feed it to petsc (SNESSetJacobian(snes,J,P,MatMFFDComputeJacobian,0);) and ask to perform something like LU for preconditioning. It is very expensive (as I have huge system) and I would need to probably contract P_n only every 100 steps or something like this... It is probably the right direction I have to go, but it seems it will take too much memory. > > Is there other better way? :) > > Small question. If I will need to construct P_n element by element, does petsc provide some help with DMDA indexing. I usually access state U with x-index (xi), y-index (yi), z-index(zi), and dof like u[zi][yi][xi][dof]. Can I use similar indexing to access matrix elements? MatSetValuesStencil() I would construct the P matrix and use LU to start, make sure you have good Newton convergence then after everything is working well is time to investigate preconditioners for P. Barry > > > Thank you and best regards, > > Oleksandr. >